Acessibilidade / Reportar erro

Locating Eigenvalues of Perturbed Laplacian Matrices of Trees This work was presented at CNMAC 2016, Brazil.

ABSTRACT

We give a linear time algorithm to compute the number of eigenvalues of any perturbed Laplacian matrix of a tree in a given real interval. The algorithm can be applied to weighted or unweighted trees. Using our method we characterize the trees that have up to 5 distinct eigenvalues with respect to a family of perturbed Laplacian matrices that includes the adjacency and normalized Laplacian matrices as special cases, among others.

Keywords:
perturbed Laplacian matrix; eigenvalue location; trees

RESUMO

Nós apresentamos um algoritmo de tempo linear para calcular o número de autovalores de uma matriz laplaciana perturbada qualquer associada a uma árvore, num dado intervalo real. Este algoritmo pode ser aplicado a árvores com ou sem pesos. Utilizando este procedimento, obtemos uma caracterização das árvores com até cinco autovalores distintos para uma família de matrizes laplacianas perturbadas, que inclui a matriz de adjacências e a matriz laplaciana normalizada como casos particulares, entre outras.

Palavras-chave:
matriz laplaciana perturbada; localização de autovalores; árvores

1 INTRODUCTION

The Spectral Graph Theory studies the relations between the spectrum of matrices associated to graphs and structural properties of the graphs. The most commonly used representation matrix of a graph is the adjacency matrix. If G is a simple undirected graph with vertices v 1, v 2, ..., v n , the adjacency matrix A = (a ij ) of G is the real symmetric matrix of order n with entries 0 or 1, where a ij = 1 if and only if vertices v i and v j are adjacent.

A tree is a connected graph with no cycles. In 2011, Jacobs & Trevisan77. D.P. Jacobs & V. Trevisan. Locating the eigenvalues of trees. Linear Algebra and its Applications, 434 (2011), 81-88. gave a linear time algorithm to compute the number of eigenvalues of a tree in a given real interval. Their method has the important advantage of being executed directly on the tree so that the matrix is not needed explicitly. The authors observed that the algorithm had potential to be adapted to other matrices, for instance the Laplacian matrix, defined as the matrix L = D G A, where D G is the diagonal matrix whose diagonal entry ii is the degree d i of vertex v i of a graph G and A is the adjacency matrix of G.

In fact, the algorithm of Jacobs and Trevisan and the extensions that followed it became a practical and efficient tool in Spectral Graph Theory. We notice in particular the work of Fritscher et al.55. E. Fritscher, C. Hoppen, I. Rocha & V. Trevisan. On the sum of the Laplacian eigenvalues of a tree. Linear Algebra and its Applications, 435 (2011), 371-399., where the original algorithm was adapted for the Laplacian matrix of a tree and applied to prove that among all trees with n vertices, the star S n has the highest Laplacian energy, which was conjectured by Radenkovic & Gutman in)88. S. Radenković & I. Gutman. Total π -electron energy and Laplacian energy: how far the analogy goes? Journal of the Serbian Chemical Society, 73 (2007), 1343-1350.. Besides, Braga et al.33. R.O. Braga, R.R. Del-Vecchio, V.M. Rodrigues & V. Trevisan. Trees with 4 or 5 distinct normalized Laplacian eigenvalues. Linear Algebra and its Applications, 471 (2015), 615-635. adapted the original algorithm for the normalized Laplacian matrix, introduced by Chung44. F.R.K. Chung. “Spectral Graph Theory”, American Math. Soc., Providence, (1997). as the matrix L = (ℓij ), where ℓij = 1 if i = j and d i > 0, ij=-1di·dj, if vertices v i and v j are adjacent, and ℓij = 0, otherwise. This variation of the algorithm was used to study the multiplicity of normalized Laplacian eigenvalues of small diameter trees, which allowed the authors to characterize the trees that have up to 5 distinct normalized Laplacian eigenvalues.

The results obtained with the localization algorithm for different representation matrices of trees motivated the development of an algorithm to localize the eigenvalues of a tree for a more general class of matrices, generalizing the previous algorithms, which is the aim of this work.

A weighted graph is a graph where a real number ω(e ij ) = ωij is assigned to each edge e ij connecting vertices v i and v j . We say that ωij is the weight of edge e ij . An unweighted graph can be considered as a graph where all edges have weight 1. In11. R.B. Bapat, S.J. Kirkland & S. Pati. The perturbed Laplacian matrix of a graph. Linear and Multilinear Algebra, 49 (2001), 219-242., Bapat et al. defined the perturbed Laplacian matrix of a graph with positive weights, which encompasses the adjacency, Laplacian and normalized Laplacian matrices, among others. Given a real diagonal matrix D, the perturbed Laplacian matrix of G with respect to D, is the matrix

L D ( G ) = D - A ,

where A = (a ij ) is the adjacency matrix of G, with a ij = ωij if vertices v i and vj are adjacent, and 0 otherwise.

The general idea of the localization algorithm for a perturbed Laplacian matrix of a weig ted tree, called DiagonalizeW, is the same of the previous algorithms: performing computations directly on the tree, obtain a diagonal matrix D α congruent to M + α I, where M is a representation matrix of a tree.

Beyond preserving the practicality of the original algorithm and its extensions, our method has the advantages of considering weighted trees and allowing to simultaneously derive results for several representation matrices. In fact, the previous localization algorithms are special cases of algorithm DiagonalizeW. For an unweighted tree, if D is the zero matrix then D L (G) = -A and DiagonalizeW coincides with the algorithm given in77. D.P. Jacobs & V. Trevisan. Locating the eigenvalues of trees. Linear Algebra and its Applications, 434 (2011), 81-88.. If D is the diagonal matrix of the degrees of the vertices of G, then D L (G) is the Laplacian matrix of G and DiagonalizeW coincides with the algorithm applied in55. E. Fritscher, C. Hoppen, I. Rocha & V. Trevisan. On the sum of the Laplacian eigenvalues of a tree. Linear Algebra and its Applications, 435 (2011), 371-399.. Besides, if D is the identity matrix and we taked ωij = 1di·djDiagonalizeW is the algorithm for the normalized Laplacian matrix given in33. R.O. Braga, R.R. Del-Vecchio, V.M. Rodrigues & V. Trevisan. Trees with 4 or 5 distinct normalized Laplacian eigenvalues. Linear Algebra and its Applications, 471 (2015), 615-635..

In Section 2 we present algorithm DiagonalizeW. In Section 3 we apply this method to characterize the trees that have up to 5 distinct eigenvalues with respect to a family of perturbed Laplacian matrices that includes the adjacency and normalized Laplacian matrices as special cases, among others.

2 LOCATING EIGENVALUES OF PERTURBED LAPLACIAN MATRICES

Taking as input a weighted tree T of order n, a scalar α ∈ R and a real diagonal matrix D, the algorithm DiagonalizeW(T, α) that we present in this section diagonalizes the matrix D L (T) + αI, where D L (T) is the perturbed Laplacian matrix of T with respect to D. The output is a diagonal matrix Dα congruent to D L (T) + αI. We recall that two square matrices of order n, A and B, are congruent if there is an invertible matrix P such that A = P T BP.

Like the original algorithm of Jacobs and Trevisan for the adjacency matrix, our method is executed directly on the tree T, so that the matrix is not needed explicitly.

The tree T is rooted at an arbitrary vertex and the vertices are ordered v 1, ..., v n , so that if v j is a child of vk, then j > k. Thus the root is the vertex v 1. Every vertex v of T, except for the root, has a parent, which is the vertex adjacent to v that is not a child of v.

During the execution the algorithm DiagonalizeW(T, α) assigns, to each vertex v i of T, a real value a(vi) which at the end corresponds precisely to the entry ii of the diagonal matrix D α. We call a(v i ) the diagonal value of vertex v i . Initially, each v i receives the diagonal value a(v i ) = δi + α, where δi is the entry ii of the diagonal matrix D. Then the vertices are processed bottom-up, towards the root, as described below. For a vertex v k , we denote by C k the set of all children of vk. If v k is a leaf which is not the root, then Ck = ∅.

To understand how the procedure above computes the diagonal values of a diagonal matrix congruent to the matrix D L (T) + αI, let us consider a vertex v k of T with a child v j , which corresponds to the entries in the matrix below:

k j a ( v k ) ω k j ω j k a ( v j ) .

If a(v j ) ≠ 0, then the following row and column operations annihilate the entries k j and j k:

R k R k ω j k a ( υ j ) R j and C k C k ω j k a ( υ j ) C j .

After these two operations, the corresponding entries of the matrix are

k j a ( v k ) - ( ω k j ) 2 a ( v j ) 0 0 a ( v j ) .

Note that if v k has all children with nonzero diagonal values, each of them may be used to annihilate the two off-diagonal entries that correspond to its connection with v k . Hence, after performing the same operations for all children of v k , the diagonal value of v k becomes

a ( v k ) - v i C k ( ω i k ) 2 a ( v i ) ,

which corresponds to the value assigned by Algorithm 1 in this case (Step 1).

Algorithm 1
DiagonalizeW(T, α).

Suppose that vk has a child v j with a(v j ) = 0, as in the submatrix below. Then vertex v j may be used to annihilate the two off-diagonal entries of any other child v i of v k , as well as the two entries representing the edge between v k and its parent v l , in the case v k is not the root, as follows. Note that at this point v k and v l still have their initial diagonal values, since the vertices are processed bottom-up.

k j i δ + α ω k ω k δ k + α ω k j ω k i ω j k 0 ω i k a ( v i ) .

The operations

R i R i - ω i k ω j k R j and C i C i - ω k i ω k j C j ,

annihilate the entries ik and ki, while the operations below annihilate the entries ℓk and kℓ:

R R - ω k ω j k R j and C C - ω k ω k j C j .

Note that ωjk = ωkj ≠ 0, since v j is a child of v k .

These last two operations effectively remove the edge between v k and its parent v , disconnecting the graph, which is performed in Step 2 of Algorithm 1. At this point, the submatrix with rows and columns i, j, k, ℓ has been transformed as

k j i δ + α 0 0 δ k + α ω k j 0 ω j k 0 0 a ( v i ) .

Next, the operations

R k R k - ( δ k + α ) 2 ω j k R j and C k C k - ( δ k + α ) 2 ω k j C j

annihilate the entry kk and the submatrix becomes

k j i δ + α 0 0 0 ω k j 0 ω j k 0 0 a ( v i ) .

Finally, the operations

R j R j + 1 ω k j R k , C j C j + 1 ω j k C k , R k R k - ω k j 2 R j , C k C k - ω j k 2 C j

yield the diagonalized form

k j i δ + α 0 0 - ( ω k j ) 2 2 0 0 0 2 0 a ( v i ) .

The diagonal values of v j and v k obtained after the operations above are exactly the values directly assigned by the algorithm in Step 2. We also note that all other children of v k are unaffected by the operations above, including those that might have zero values.

Considering that the diagonal values computed by algorithm DiagonalizeW(T, α) were obtained by elementary row and column operations, such that each operation performed in one row was also performed in the corresponding column, it follows that the diagonal matrix D α, whose entries are the diagonal values assigned by the algorithm, is congruent to D L (T) + αI. Therefore, by Sylvester’s Law of Inertia (see [6, Theorem 4.5.8]), we have the next result.

Theorem 2.1.Given a real diagonal matrix D, let Dαbe the diagonal matrix produced by the algorithm DiagonalizeW(T, -α) for a weighted tree T and real number α. Then, the number of positive, negative and zero diagonal entries in Dα is equal to the number of eigenvalues of the perturbed Laplacian matrix of T with respect to D, DL (T), which are greater, smaller and equal to α, respectively.

Example 2.2. Let T be the weighted tree with vertices v 1, v 2, v 3, v 4 and v 5 on the left side of Figure 1, with weights represented on the edges. Suppose that the diagonal entries of matrix D are δ1 = 1, δ2 = 2, δ3 = 1, δ4 = 1 and δ5 = 1.

Figure 1:
Algorithm DiagonalizeW(T, α) with α = −2.

Let us apply algorithm DiagonalizeW(T, α), with α = -2. The initial diagonal values assigned to the vertices are a(v i ) = δi − 2, for i = 1, ..., 5, which are represented on the vertices of T, on the left side of Figure 1.

Vertices v 4 and v 5 are the children of v 3 and have nonzero values, hence the algorithm assigns

a ( v 3 ) = - 1 - ( ω 34 ) 2 a ( v 4 ) - ( ω 35 ) 2 a ( v 5 ) = - 1 - 2 2 - 1 - 1 2 - 1 = 4 .

Vertex v 1 has a child with a zero value (vertex v 2), then the algorithm assigns value 2 to v 2, whereas the diagonal value of v 1 becomes

a ( v 1 ) = - ( ω 12 ) 2 2 = - 1 2 2 = - 1 2 .

Therefore, since the algorithm produced two positive and three negative diagonal values, it follows from Theorem 2.1 that the matrix D L (T) has two eigenvalues greater than 2 and three eigenvalues smaller than 2. Applying the algorithm with α = 0, we obtain that D L (T) has one negative and four positive eigenvalues, while with α = −1 we get that D L (T) has one eigenvalue equal to 1, two eigenvalues smaller than 1 and two eigenvalues greater than 1. Hence, D L (T) has one negative eigenvalue, one eigenvalue in the interval (0, 1), one eigenvalue equal to 1 and two eigenvalues greater than 2.

3 TREES WITH AT MOST FIVE DISTINCT EIGENVALUES WITH RESPECT A FAMILY OF PERTURBED LAPLACIAN MATRICES

In this section we apply Algorithm DiagonalizeW(T, α) to study trees that have up to 5 distinct perturbed Laplacian eigenvalues.

It follows from the Theorem below, whose proof can be found in [2, Proposition 1.3.3], that we only need to consider trees with a small diameter. We recall that the diameter of a graph is the maximum distance between any two vertices in the graph.

Theorem 3.1.If G is a connected graph with diameter d and M = (m ij ) is a nonnegative symmetric matrix with rows and columns indexed by the vertices of G and such that for distinct vertices v i ,v j we have m ij > 0 if and only if v i and v j are adjacent, then G has at least d + 1 distinct eigenvalues with respect to M.

We show next that this property is more general. For that matter we apply a result due to Schur, whose proof can be found in [6, Theorem 4.3.45].

Theorem 3.2 (Schur). Let A be a real symmetric matrix of order n with diagonal entries d 1 ≥ d 2 ≥ ... ≥ d n and eigenvalues λ 1 ≥ λ 2 ≥ ... ≥ λ n . Then

i = 1 k d i i = 1 k λ i , for k = 1 , , n - 1 , and i = 1 n d i = i = 1 n λ i .

Theorem 3.3.If G is a connected graph with positive weights and diameter d, then any perturbed Laplacian matrix of G has at least d + 1 distinct eigenvalues.

Proof. Let G be a connected graph with order n, positive weights and diameter d. Let D L (G) = D - A be the perturbed Laplacian matrix of G with respect to a diagonal matrix D = (d ij ). Let us denote the entries of the adjacency matrix of G by a ij , with i, j ∈ {1, ..., n}. Let

m = 1 + max 1 k n λ k ,

where λ1, ..., λn are the eigenvalues of D L (G), and consider the matrix B = mID L (G) = mID + A. Then, for all i, j ∈ {1, ..., n} with ij, b ij = a ij ) 0. Besides, for all i ∈ {1, ..., n}, the diagonal entry b ii = md ii of B is positive. This follows from the fact that D L (G) is symmetric and then, by Theorem 3.2, diimax1knλk < m. Therefore, by Theorem 3.1, B has at least d + 1 distinct eigenvalues. Since the eigenvalues of B are m − λ1, ..., m − λn , it follows that D L (G) has at least d + 1 distinct eigenvalues.

The perturbed Laplacian matrix of a graph depends on an arbitrary diagonal matrix D. We consider the case where D = μI, for some μ ∈ R, thus the perturbed Laplacian matrix of a graph G is of the form

L D ( G ) = μ I - A .

Note that, in particular, if μ = 0, D L (G) = −A. Besides, if G has no isolated vertices, μ = 1 and the weights of G are

ω i j = 1 d i d j ,

then D L (G) is the normalized Laplacian matrix of G 1, where G 1 is an unweighted graph with the same edges and vertices then G. Hence the adjacency matrix of a weighted graph and the normalized Laplacian matrix of an unweighted graph with no isolated vertices are special cases of a perturbed Laplacian matrix of the form D L (G) = μIA.

It is known that the spectrum of the adjacency matrix of a connected graph G is symmetric if and only if G is bipartite (see [2, Proposition 3.4.1]). The family of perturbed Laplacian matrices that we are considering satisfies a similar result. It is easy to see that the spectrum of μIA is symmetric about μ ∈ R if and only if the spectrum of A is symmetric. In fact, if λ is an eigenvalue of μIA, then μ − λ is an eigenvalue of A. Hence, if the spectrum of A is symmetric, then λ − μ is also an eigenvalue of A. Thus, μ − (λ − μ) = 2μ − λ is an eigenvalue of μIA. The converse is similar.

Theorem 3.4.Let G be a connected weighted graph of order n and μ ∈ R. Then G is bipartite if and only if the spectrum of D L (G) = μI − A is symmetric about μ.

In order to characterize the trees that have at most five distinct eigenvalues for perturbed Laplacian matrices of the form μIA, for some μ ∈ R, by Theorem 3.3 it is enough to consider trees with diameter smaller than five, since every tree is a connected graph. Besides, every tree T is a bipartite graph, so the spectrum of D L (T) = μIA is symmetric about μ.

Let T bea tree with n vertices and diameter d less than or equal to 4. If d = 1, T is the complete graph with two vertices and has two different eigenvalues: μ + ω and μ − ω, where ω is the weight of the edge that connects the vertices.

In the case d = 2, T is the star S n , that has exactly three distinct eigenvalues, symmetric about μ, which is an eigenvalue with multiplicity to n − 2. To see that, we apply algorithm DiagonalizeW(S n , α), with α = −μ and the vertex with degree n - 1 as the root. Since all n - 1 pendants of Sn receive zero diagonal values, the algorithm assigns to the root v the diagonal value -(ωvy*)22, where y * is a pendant of v selected to receive value 2. Therefore, exactly n − 2 vertices have a zero diagonal value at the end of the execution, which implies that μ is an eigenvalue with multiplicity to n − 2, by Theorem 2.1.

Now we consider the case d = 3. Note that any diameter 3 tree can be seen as two stars S k + 1 and S ℓ +1, where k, ℓ ≥ 1, with an edge linking their centers, as illustrated in Figure 2.

Figure 2:
A diameter 3 tree.

Applying algorithm DiagonalizeW, we obtain the following result.

Theorem 3.5.Let T be a diameter 3 tree. Then all eigenvalues of DL (T) = μIA, except possibly for μ, are simple. Moreover, D L (T) has exactly four eigenvalues if and only if T = P 4, the path with four vertices. Otherwise, D L (T ) has exactly five distinct eigenvalues.

Proof. Let T be a diameter 3 tree with n = k + ℓ + 2 vertices, as shown in Figure 2. By Theorem 3.3, D L (T) = μIA has at least four distinct eigenvalues. If n = 4, T is the path P 4 and D L (T) has exactly four distinct eigenvalues. Suppose that n > 4 and let us apply the algorithm DiagonalizeW(T, α), with α = −μ and T rooted at the vertex with ℓ pendants. Then all vertices are initialized with a zero value. Since all k pendants of the vertex adjacent to the root have zero values, when this vertex is processed its diagonal value becomes negative and one of its k pendants receives a positive value. Besides, since ℓ ≥ 1, the root has at least one pendant with a zero value. Hence, when the algorithm processes the root, its diagonal value becomes negative and exactly one of its ℓ pendants receives a positive value. Therefore, at the end of the execution we obtain k + ℓ − 2 = n − 4 zero values. By Theorem 2.1, it follows that μ is an eigenvalue of D L (T) with multiplicity n − 4. Then the other four eigenvalues of D L (T) must be distinct since it has at least four distinct eigenvalues and its spectrum is symmetric about μ. Hence, D L (T) has exactly five distinct eigenvalues if n > 4, which concludes the proof.

If T has diameter d = 4, then D L (T) has at least five distinct eigenvalues. Hence, the path P 4 is the only tree with exactly four distinct eigenvalues. We want to characterize the trees, if any, necessarily of diameter 4, that have exactly five distinct eigenvalues for the perturbed Laplacian matrix μIA. Every diameter 4 tree is of the form depicted in Figure 3: it contains a vertex v adjacent to k ≥ 2 vertices v 1, ..., v k , where v i has degree p i + 1, with p i ≥ 1, for i = 1, ..., k, and each v i is adjacent to p i pendants, and v is also possibly adjacent to m ≥ 0 pendants. In this case, we write T = T (k, p 1, p 2, ..., p k , m).

Figure 3:
A diameter 4 tree T (k, p1, p2, ..., pk, m).

The following result gives the multiplicity of μ as an eigenvalue of D L (T) = μIA, where T is a diameter 4 tree.

Theorem 3.6.For any diameter 4 tree of the form T = T (k, p1, p2, ..., pk, m), the multiplicity of μ as an eigenvalue of μI − A is 1 − k +i=1kpi≥ 1, when m = 0, and m − 1 − k +i=1kpi, when m > 0.

Proof. Let us apply the algorithm DiagonalizeW(T, α), with α = −μ, to T rooted at vertex v of degree k + m, which is adjacent to the vertices v 1, v 2, ..., v k of degree p 1 + 1, ..., p k + 1, respectiely.

Suppose that m = 0, that is, v has no pendants. Since μ+α = 0, initially all vertices are assigned a zero diagonal value, as the left hand-side of Figure 4 shows. Next, for i = 1, ..., k, the value of v i becomes -(ωvivi*)22, where vi* is a pendant of vi chosen to take value 2, and the edge connecting v i to v is removed, so that the value of the root v remains 0. The other Σ (p i − 1) pendants also remain with a zero diagonal value, as illustrated in the right-hand side of Figure 4. Therefore, by Theorem 2.1, the multiplicity of μ as an eigenvalue of D L (T) = μIA is exactly

i = 1 k ( p i - 1 ) + 1 = i = 1 k p i - k + 1 1 .

Figure 4:
A diameter 4 tree with m = 0.

Now suppose that m > 0. Figure 5 illustrates the execution the algorithm in this case. All the edges connecting the v i ’s to v are also removed.

Figure 5:
A diameter 4 tree with m > 0.

When the root v is processed, since it remains connected only to its m pendants, which have value 0, the value assigned to v becomes -(ωvv*)22, where v * is a pendant of v chosen to take value 2. Hence, by Theorem 2.1, the multiplicity of μ as an eigenvalue of D L (T) = μIA is

i = 1 k p i - k + ( m - 1 ) .

The next result gives the multiplicity of the eigenvalues of D L (T) = μIA that are different from μ for a diameter 4 tree T. For i = 1, ..., k, let ωih be the weight of the edge that connects v i to its pendant q ih , for h = 1, ..., p i , and let σi = h=1pi(ωih)2.

Theorem 3.7.Let T = T(k, p1, p2, ..., pk, m) be a diameter 4 tree. Then D L (T ) = μI − A has an eigenvalue different from μ with multiplicity t ≥ 2 if and only if t < k and exactly t + 1σi'sare equal. Moreover, λ 1 = μ −σand λ 2 = μ +σare eigenvalues of D L (T) = μI − A with multiplicity t ≥ 1 if σ i = σ for exactly t + 1vi's.

Proof. Let us suppose that λ ≠ μ is an eigenvalue of D L (T) with multiplicity t ≥ 2. Applying algorithm DiagonalizeW(T, −λ) to T rooted at vertex v of degree k + m, each pendant of T receives the initial diagonal value μ − λ ≠ 0. Hence,

a ( v i ) = μ - λ - h = 1 p i ( ω i h ) 2 μ - λ = μ - λ - σ i μ - λ ,

for all 1 ≤ ik. Due to the multiplicity of λ, the algorithm produces exactly t zero diagonal values. Considering that each pendant of T has a nonzero diagonal value and t ≥ 2, then a(v i ) = 0 for at least one i, since otherwise the only possible zero diagonal value would be a(v), which contradicts the fact that t ≥ 2. Thus, the only way to obtain exactly t zero diagonal values at the end of the algorithm is that a(v i ) = 0 for exactly t + 1 v i s, so that, after processing vertex v, the diagonal value of v is negative and one of those t + 1 v i s has a positive diagonal value. This implies that t + 1 ≤ k. Besides, for 1 ≤ i < jk,

a ( v i ) = a ( v j ) μ - λ - σ i μ - λ = μ - λ - σ j μ - λ σ i = σ j .

Without loss of generality, now let us suppose that for some t, 1 ≤ t < k, there exists σ ∈ R such that σi = σ , for all i, 1 ≤ it + 1, and σi ≠ σ, for i > t + 1. We apply algorithm DiagonalizeW(T, α) to T rooted at vertex v of degree k + m and α = −λ, where λ = μ − σ. Initially all pendants of T are assigned a diagonal value μ − λ = σ, which is positive. Besides, for each i, 1 ≤ it + 1, v i is assigned a zero value, since

a ( v i ) = μ - λ - σ i μ - λ = ( μ - λ ) 2 - σ μ - λ = 0 .

Therefore, when vertex v is processed, we obtain a(v j ) = 2, for exactly one j in {1, ..., t + 1} and a(v) = -(ωvvj)22 < 0. Hence, at the end of the execution, there are exactly t zero diagonal values, which implies that λ is an eigenvalue of D L (T) with multiplicity t. The result for λ = μ + σ follows from the symmetry of the spectrum of D L (T) = μIA with respect to μ (Theorem 3.4).

Corollary 3.1.If σi≠ σ j for all 1 ≤ i < j ≤ k, then, except possibly by μ, all eigenvalues of D L (T) = μI − A are simple.

The result below characterizes the diameter 4 trees for which the perturbed Laplacian matrix of the form μIA has exactly 5 distinct eigenvalues.

Theorem 3.8.Let T = T (k, p1, p2, ..., pk, m) be a diameter 4 tree. If m = 0 and k = 2, or m = 0, k ≥ 3 and σ i = σ j , for all 1i < jk, then D L (T) = μI − A has exactly 5 distinct eigenvalues. Otherwise, D L (T) has at least 6 distinct eigenvalues.

Proof. If m = 0, then, by Theorem 3.6, the multiplicity of μ as an eigenvalue of D L (T) = μIA is 1 − k + i=1kpi ≥ 1. Hence, D L (T) has exactly 2k eigenvalues different from μ. If k = 2, the result is clear, since T has at least 5 distinct eigenvalues by Theorem 3.3. Let us suppose that k ≥ 3. If σi = h=1pi(ωih)2 = σ, for all 1 ≤ ik, by Theorem 3.7, λ1 = μ + σ and λ2 = μ − σ are eigenvalues of D L (T) with multiplicity k − 1 ≥ 1. Hence D L (T) has 2k − (2(k − 1)) = 2 eigenvalues different from μ, λ1 and λ2. These two eigenvalues are simple, since the spectrum of D L (T) is symmetric about μ (Theorem 3.4), which shows that D L (T) has exactly 5 distinct eigenvalues.

However, if σi = σ , for all 1 ≤ it , for some 2 ≤ t < k, and σi ≠ σ , for all i > t, the multiplicity of λ1 and λ2 is t − 1. Hence D L (T) has 2(kt + 1)) ≥ 4 eigenvalues different from μ, λ1 and λ2, which implies that D L (T) has at least 7 distinct eigenvalues. If σi ≠ σj , for all 1 ≤ i < j k , by Corollary 3.1, D L (T) has 2k ≥ 6 simple eigenvalues different from μ, which shows that D L (T) has at least 7 distinct eigenvalues. Finally, if m > 0 and k ≥ 2, by Theorem 3.6, the multiplicity of μ is m − 1 − k + i=1kpi ≥ 0 and D L (T) has 2k + 2 ≥ 6 eigenvalues different from μ. By Theorems 3.4 and 3.7, it follows that D L (T) has at least 6 distinct eigenvalues, since in this case the multiplicity of μ can be zero.

REFERENCES

  • 1
    R.B. Bapat, S.J. Kirkland & S. Pati. The perturbed Laplacian matrix of a graph. Linear and Multilinear Algebra, 49 (2001), 219-242.
  • 2
    A.E. Brouwer & W.H. Haemers. “Spectra of graphs”, Springer, New York, (2012).
  • 3
    R.O. Braga, R.R. Del-Vecchio, V.M. Rodrigues & V. Trevisan. Trees with 4 or 5 distinct normalized Laplacian eigenvalues. Linear Algebra and its Applications, 471 (2015), 615-635.
  • 4
    F.R.K. Chung. “Spectral Graph Theory”, American Math. Soc., Providence, (1997).
  • 5
    E. Fritscher, C. Hoppen, I. Rocha & V. Trevisan. On the sum of the Laplacian eigenvalues of a tree. Linear Algebra and its Applications, 435 (2011), 371-399.
  • 6
    R. Horn & C.R. Johnson. “Matrix Analysis”, Cambridge University Press, (1985).
  • 7
    D.P. Jacobs & V. Trevisan. Locating the eigenvalues of trees. Linear Algebra and its Applications, 434 (2011), 81-88.
  • 8
    S. Radenković & I. Gutman. Total π -electron energy and Laplacian energy: how far the analogy goes? Journal of the Serbian Chemical Society, 73 (2007), 1343-1350.
  • This work was presented at CNMAC 2016, Brazil.

Publication Dates

  • Publication in this collection
    Sep-Dec 2017

History

  • Received
    01 Dec 2016
  • Accepted
    17 May 2017
Sociedade Brasileira de Matemática Aplicada e Computacional Rua Maestro João Seppe, nº. 900, 16º. andar - Sala 163 , 13561-120 São Carlos - SP, Tel. / Fax: (55 16) 3412-9752 - São Carlos - SP - Brazil
E-mail: sbmac@sbmac.org.br