Home On the N-spectrum of oriented graphs
Article Open Access

On the N-spectrum of oriented graphs

  • Mohammad Abudayah EMAIL logo , Omar Alomari and Torsten Sander
Published/Copyright: June 4, 2020

Abstract

Given any digraph D, its non-negative spectrum (or N-spectrum, shortly) consists of the eigenvalues of the matrix AA T , where A is the adjacency matrix of D. In this study, we relate the classical spectrum of undirected graphs to the N-spectrum of their oriented counterparts, permitting us to derive spectral bounds. Moreover, we study the spectral effects caused by certain modifications of a given digraph.

MSC 2010: 05C50; 15A18

1 Introduction

The study of graph eigenvalues has a long history. Starting with classical applications in mathematical chemistry (see [1] and chapter 8 of [2]), further applications have been found in combinatorics (see [3,4,5]), combinatorial optimization (see [6,7]) and also in theoretical computer science (see [8]).

On the other hand, research on the spectrum of directed graphs is relatively rare compared to that of undirected graphs. The main reason is that the adjacency matrix of a digraph in general is difficult to work with. It is not symmetric (so we lose the property that eigenvalues are real) and not diagonalizable (hence the dimension of an eigenspace may differ from the algebraic multiplicity of the corresponding eigenvalue in the characteristic polynomial).

Many researchers have proposed definitions of Hermitian matrices to represent digraphs. For example, Guo and Mohar (see [9]) defined the so-called Hermitian adjacency matrix of a digraph D as follows: given a digraph D with vertex set V and arc set E, the Hermitian adjacency matrix of D is the matrix H(D) = [h uv ] with

h u v = { 1 if u v E and v u E , i if u v E and v u E , i if u v E and v u E , 0 otherwise .

If D is an oriented graph, then the above definition can be tailored to the matrix iAiA T , where A is the well-known adjacency matrix of D.

Another way of defining an alternative version of the adjacency matrix – as it was done by Jovanović in [10] – is to consider the eigenvalues of the matrix N out ( D ) A A T for any given digraph D, where A is the classical adjacency matrix of D. N out(D) is symmetric, so it has many of the well-known benefits of the classical adjacency matrix of an undirected graph. Moreover, N out(D) is positive semi-definite, hence Jovanović called the spectrum of this matrix the non-negative spectrum of a digraph or, shortly, the N-spectrum. Note the relation of this definition to the singular values of a digraph D, defined to be the square roots of the eigenvalues of the matrix AA T .

In what follows, we will use the N-spectrum of oriented graphs as a tool to find upper bounds on the spectral radius, in particular of bipartite graphs. Moreover, we investigate how modifying a digraph will affect the N-spectrum of this digraph.

2 Preliminaries

A directed graph (or digraph) D = (V, E) consists of a set of vertices V = {v 1, v 2,…,v n } and a set of arcs EV × V. Hereafter, we assume that all digraphs considered are loopless, i.e., E does not contain any entries of the form (v i , v i ). The adjacency matrix A = [a ij ] of D is the square matrix of order n such that a ij = 1 if (v i , v j ) ∈ E and a ij = 0 otherwise. A vertex v j is an incoming neighbor (or, shortly, an in-neighbor) of v i if (v j , v i ) ∈ E. Conversely, we call v i an outgoing neighbor (or out-neighbor) of v j . The set of outgoing (resp. incoming) neighbors of a vertex v i is denoted by N+(v i ) (resp. N(v i )). Moreover, we define the out-degree deg+(v i ) = |N+(v i )| and in-degree deg(v i ) = |N(v i )|. A vertex without any incoming neighbors is called a source, whereas a vertex without outgoing neighbors is termed a sink.

A digraph with symmetric relation E can be interpreted as an (undirected) graph G, by identifying arc pairs (v i , v j ) and (v j , v i ) and interpreting them as a single edge between the two vertices. Hence, the two notions of neighborhood (resp. degree) coincide so that we write N(v i ) for the set of neighbors of v i in G and deg(v i ) = |N(v i )|. The multiset σ(G) of eigenvalues λ 1(G) ≥…≥ λ n (G) of the (symmetric) adjacency matrix of G (in which the multiplicity of each eigenvalue matches the dimension of its eigenspace) is called the spectrum of G. The largest eigenvalue is called the spectral radius of G.

Given a digraph D with adjacency matrix A n × n , the eigenvalues μ 1(D) ≥…≥ μ n (D) of the symmetric matrix N out ( D ) A A T are called the N-eigenvalues of D. The largest (N-)eigenvalue modulus is achieved by λ 1 and called the (N-)spectral radius. The multiset σ N(D) of N-eigenvalues of D is called the N-spectrum of D. As mentioned in Section 1, these definitions are originally motivated by the fact that AA T is positive semi-definite. Observe that an alternate definition can be obtained by considering the matrix A T A. Determining the N-eigenvalues according to one definition yields the same result as if using the alternate definition on the digraph after the directions of all of its arcs have been reversed.

Note that the entry of AA T found at position (i, j) represents the number of common out-neighbors of the vertices v i and v j in D. In particular, the entry found at position (i, i) represents the out-degree of the vertex v i . We immediately deduce that the trace of AA T equals |E|, which in turn equals the sum of all N-eigenvalues of D (where we count each eigenvalue according to its multiplicity). As a consequence, D contains only isolated vertices if and only if all of its N-eigenvalues are zero.

When it comes to analyzing the N-spectrum of a digraph, it is possible to conveniently choose a vertex order such that the matrix AA T assumes the block diagonal form. Following [11], we define a zig-zag trail (of length 2l) between two vertices x and y to be a sequence of arcs

( x , u 1 ) , ( v 1 , u 1 ) , ( v 1 , u 2 ) , ( v 2 , u 2 ) , , ( u l , v l ) , ( y , v l )

such that it starts with a forward arc from x, then a reverse arc, then again a forward arc, and so on, until we reach y with a backward arc. A path of length zero is also considered a zig-zag trail. Next, two vertices shall be related to each other if they have a zig-zag trail between them. It is easy to see that this relation is an equivalence relation. Therefore, it partitions the vertex set V into subsets { 1 , 2 , , k } . This partition is called common out-neighbor partition. Renumbering the vertices of V starting with vertices in 1 then 2 and so on will result in the desired block diagonal matrix form. This follows directly from the interpretation of the entries of AA T that we gave in the previous paragraph.

As an example, consider the digraph in Figure 1. The grey vertices form the largest block of the common out-neighbor partition. The black vertices form a block of two vertices, whereas each of the white vertices forms a singleton block. The chosen vertex order is consistent with the proposed way of numbering the vertices according to the common out-neighbor partition. Hence, we get the following matrix:

Figure 1 
               A digraph and its common out-neighbor partition.
Figure 1

A digraph and its common out-neighbor partition.

Using the common out-neighbor partition, it is possible to relate the N-eigenvalues of certain directed bipartite graphs to the classical eigenvalues of their undirected counterparts. A bipartite graph is a graph whose vertex set V can be partitioned into two subsets V 1, V 2 such that neither of the two subgraphs induced by V 1 resp. V 2 contains any edges.

Theorem 1

(Square Theorem [11]). Let D be a bipartite digraph such that each vertex is either a source or a sink. For any vector x n , we may construct its source part by setting all those entries of x to zero which correspond to the non-sources (i.e. sinks) of D. Likewise, we construct the sink part of x. Let k be the number of sources and l be the number of sinks in D. Furthermore, let G be the underlying undirected graph of D.

  1. Given an eigenspace basis for eigenvalue λ ≠ 0 of G, the source parts of these vectors form an N-eigenspace basis for N-eigenvalue λ2 of D and their sink parts are all N-eigenvectors for N-eigenvalue 0 of D.

  2. Every eigenvector for eigenvalue 0 of G is also an N-eigenvector for N-eigenvalue 0 of D.

  3. If the source part of any N-eigenvector for N-eigenvalue 0 of D is not null, then this source part is an eigenvector for eigenvalue 0 of G.

  4. Given a basis of k + l of eigenvectors of G, an N-eigenspace basis for N-eigenvalue 0 of D can be constructed as follows. Collect the sink parts of all the vectors associated with positive eigenvalues of G, together with the vectors associated with eigenvalue 0. Alternatively, collect the source parts of all vectors of the given basis and determine a maximal linearly independent subset of resulting set, together with l unit vectors, one for each sink (such that it is non-zero exactly on the considered sink).

Note that the digraph D mentioned in Theorem 1 is actually an oriented graph.

3 Upper bounds for the spectrum of a graph

Study of the spectral radius of graphs has been a prominent research topic in the spectral graph theory since its inception in the 1950s to this day. In 1990, Cvetković and Rowlinson (see [12]) surveyed numerous results on the spectral radius. This is complemented by a more recent survey by Stevanović (see [13]). In this section, we introduce new upper bounds for the spectral radius of graphs. We use the N-spectra of certain oriented graphs to establish these bounds.

Recall that a graph is bipartite if and only if its vertex set can be partitioned into two sets such that the end points of each edge belong to different sets. For what follows, we introduce the notion of zig-zag orientation of a bipartite graph. To this end, we simply choose one set of its vertex bipartition and orient all arcs of the graph toward this set. As a result, we obtain an oriented graph in which each vertex is either a source or a sink.

Theorem 2

For any bipartite graph G = (V, E), we have

λ 1 ( G ) max u V v N ( u ) deg ( v ) ,

where λ 1(G) is the largest eigenvalue of G.

Proof

Let D be a digraph obtained by zig-zag orientation of the given graph G such that the vertices are numbered according to the common out-neighbor partition. Let N out(D) = [a ij ]. Using Theorem 1 and observing that the largest singular value of a matrix M is equal to its spectral matrix norm ∥M∥ (see [14]), we obtain

λ 1 2 ( G ) = N out ( D ) N out ( D ) = max i j a i j ,

where ∥N out(D)∥ is the maximum row sum norm of the matrix N out(D).

Note that the row in N out(D) corresponding to the vertex u has row sum equal to deg+(u) plus the number of common out-neighbor vertices with vertices in the same partite class as u. However, the number of common out-neighbor vertices with vertices in the same partite class of u is exactly

v N ( u ) ( deg ( v ) 1 ) .

Since D has a zig-zag orientation, we have deg D ( v ) = deg G ( v ) and deg D + ( u ) = deg G ( u ) . Therefore,

λ 1 2 ( G ) max u V ( deg ( u ) + v N ( u ) ( deg ( v ) 1 ) ) = max u V ( deg ( u ) + v N ( u ) ( v ) | N ( u ) | ) = max u V ( v N ( u ) deg ( v ) ) .

Let us mention that the above upper bound is related to the Brualdi–Hoffman conjecture, which states λ 1 ( G ) | E | for any graph G (see [15]). This conjecture has already been settled by Bhattacharya et al. [16]. In the special case of bipartite graphs, the upper bound given in Theorem 2 is tighter than the upper bound given by the Brualdi–Hoffman conjecture.

The following theorem gives an upper bound for the spectral radius of any graph G in terms of the N-spectral radius of some orientation of this graph into a digraph D.

Theorem 3

Let G be a graph and D an oriented graph whose unoriented counterpart is G. Then,

λ 1 ( G ) 2 μ 1 ( D ) ,

where λ 1(G) is the largest eigenvalue of G and μ 1(D) is the largest N-eigenvalue of D.

Proof

Suppose that the adjacency matrix of D is A. Then, the adjacency matrix of G is A + A T . Now observe that

2 A 2 A T A + A A T .

It follows that

( A + A T ) 2 = A 2 + A A T + A T A + ( A T ) 2 A 2 + ( A T ) 2 + A A T + A T A 1 2 A T A + A A T + 1 2 A T A + A A T + 2 A A T 4 A A T .

Consequently, λ 1 2 ( G ) 4 μ 1 ( D ) and finally λ 1 ( G ) 2 μ 1 ( D ) .□

An immediate question arises when thinking about applying Theorem 3: which orientation yields the lowest upper bound? In the following we turn our attention to grid graphs and show that the inequality mentioned in Theorem 3 is sharp.

Let P i denote the path with i vertices. A grid is a graph that is isomorphic to the Cartesian product P n × P m . For the sake of simplicity, we shall assume that its vertex set is the set of all pairs (i, j) such that i ∈ {1,…,n} and j ∈ {1,…,m}. Thus, two vertices (i, j), (k, l) of a grid are adjacent if and only if either |ik| = 1 and j = l or if i = k and |j − l| = 1. Figure 2 depicts a grid P 5 × P 6 that has been oriented. Note that the chosen layout gives us a notion of the vertical/horizontal direction. We find that vertex (i, j) lies in row number i and column number k of the grid. With this image before our eyes, we define the rows k = { ( k , j ) } j = 1 , , m and columns C k = { ( i , k ) } i = 1 , , n of a grid.

Figure 2 
			A grid P5 × P6 oriented according to Lemma 2.
Figure 2

A grid P5 × P6 oriented according to Lemma 2.

Lemma 1

Let D be an oriented graph obtained from zig-zag orientation of a given path P n such that at least one of its leaves becomes a source. Then, the characteristic polynomial of the principal submatrix of N out(D) corresponding to the sources of D is

j = 1 n 2 ( x 4 cos 2 ( π j n + 1 ) ) .

Proof

The claim is implicit in the proof of Corollary 4 in [11]. To prove it, we recall the well-known fact (see e.g. [4]) that the eigenvalues of P n are

(1) 2 cos ( π j n + 1 ) , for j = 1 , , n .

For j = 1 , , n 2 these eigenvalues are distinct positive numbers. Using Theorem 1, they can be directly attributed to the sources of D. If n is odd, one needs to add a zero eigenvalue, namely the one obtained for j = n 2 . Thus, we get the formula

x n 2 n 2 j = 1 n 2 ( x 4 cos 2 ( π j n + 1 ) ) ,

which then can be simplified to get the desired result.□

Lemma 2

Let D be the oriented graph obtained from orienting a given grid P n × P m as follows:

  1. Any path induced by an odd column C 2 l + 1 has zig-zag orientation, with starting arc (2, 2l + 1)(1, 2l + 1).

  1. Any path induced by an even column C 2 l has zig-zag orientation, with starting arc (1, 2l)(2, 2l).

  1. Any path induced by an odd row 2 k + 1 has zig-zag orientation, with starting arc (2k + 1, 1)(2k + 1, 2).

  2. Any path induced by an even row 2 k has zig-zag orientation, with starting arc (2k, 2)(2k, 1).

Then,

σ N ( D ) = { 0 ( d ) } { 4 cos 2 ( π i n + 1 ) ( m 2 ) } i = 1 n { 4 cos 2 ( π j m + 1 ) ( n 2 ) } j = 1 m ,

where d = ( m 2 m 2 ) n 2 + ( n 2 n 2 ) m 2 .

Proof

First observe that, by the definition of the particular orientation, there exist neither sources nor sinks in D. Now suppose that (i,j) and (i + 1, j + 1) have a common out-neighbor, say (i, j + 1). Since both the path induced by the vertices (k, j + 1) with k ∈ {1,…,n} and the path induced by the vertices (i, k) with k ∈ {1,…,m} have zig-zag orientation, it actually follows that (i, j + 1) must be a sink – a contradiction. As a result, common neighbors can only occur along those zig-zag paths that were explicitly mentioned in the definition of the chosen orientation. No other zig-zag paths exist in D.

Let us divide the vertices according to whether they belong to an even or odd diagonal of the grid. To this end, let D 1 = { ( i , j ) :   i j is even } and D 2 = { ( i , j ) :   i j is odd } .

Observe that 1 , k D 1 k contains exactly the sources of the subgraph of D induced by the vertex set k . Moreover, 2 , l D 2 C l contains exactly the sources of the subgraph of D induced by the vertex set C l . Since no other zig-zag paths exist in D apart from those induced by the separate rows and columns of the grid it follows that the sets

1 , 1 , , 1 , n , 2 , 1 , , 2 , m

form the common out-neighbor partition of D. Hence, we may use Lemma 1 to determine the characteristic polynomial of N out(D) on a per-block basis, where each block can also be obtained “locally” by considering a suitable zig-zag-oriented path and determining the block of its N out matrix corresponding to the sources of that path. Moreover, keep in mind that the zig-zag paths of two neighboring columns or rows can be transformed into each other by reversing the orientation. Hence, their N-spectrum is the same.

Let us define

S k ( x ) j = 1 k 2 ( x 4 cos 2 ( π j k + 1 ) ) .

If both n and m are even, then it is a direct consequence of Lemma 1 that χ(D;x) = S n (x) m S m (x) n . In the case of odd n we need to consider that the zig-zag paths contained in the grid columns, alternatingly, contain n 2 and n 2 sinks (as can easily be seen from Figure 2). For each column that contains n 2 local sinks we need to add a zero N-eigenvalue. This happens m 2 times. For the case when m is odd we need to consider that the zig-zag paths contained in the grid rows, alternatingly, contain m 2 and m 2 sinks. A zero N-eigenvalue needs to be added whenever there are m 2 local sinks per row. Observing the slightly different pattern, we see that this happens only n 2 times. All in all, we obtain χ(D;x) = S n (x) m S m (x) n x d .□

Theorem 4

The minimum N-spectral radius of any oriented grid P n × P n can be achieved by using the orientation described in Lemma 2.

Proof

Let D be the digraph with underlying graph P n × P n and orientation as described in Lemma 2. It follows from Theorem 3 that

λ 1 ( P n × P n ) 2 μ 1 ( D ) ,

but by Eq. (1) and Lemma 2 we have

2 μ 1 ( D ) = 2 4 cos 2 ( π n + 1 ) = 4 cos ( π n + 1 ) = 2 λ 1 ( P n ) = λ 1 ( P n × P n ) .

Example 1

Consider the grid P 5 × P 5 . It has a spectral radius of approximately 3.46. As predicted by Theorem 4, this matches the bound we deduce from the N-spectral radius 3 achieved by zig-zag orientation of the given grid. Alternatively, orient all “horizontal” arcs from left to right and all “vertical” arcs from top to bottom. Then, we obtain an N-spectral radius of approximately 3.62, which only yields an upper bound of 3.81 for the spectral radius of the grid P 5 × P 5 .

4 Effects of modification

It is interesting to study how modifying a given digraph reflects in changes of its N-spectrum. Several modifications have already been considered in [10] and [11]. In this section, we want to focus on N-eigenvalue interlacing. Probably, the most classical theorem about eigenvalue interlacing is the following.

Theorem 5

(cf. [4]). Let G be a graph (resp. a symmetric matrix) with eigenvalues λ 1 ≥…≥ λ n and H an induced subgraph (resp. a principal submatrix) of G with eigenvalues μ 1 ≥…≥ μ m . Then,

λ k μ k n + m λ k n + m ( for k = 1 , , 2 n m ) .

The special case m = n − 1 gives us the following inequality chain:

λ 1 μ 1 λ 2 μ 2 λ 3 μ n 2 λ n 1 μ n 1 λ n .

When it comes to the N-spectrum, deriving any helpful interlacing theorems at all turns out to be quite a challenge. At least, Jovanović has been able to derive the following “edge version” of the interlacing theorem.

Theorem 6

(cf. [10]). Let D be a weakly connected digraph of order n, with N-eigenvalues λ 1 ≥…≥ λ n . Assume that D has at least one vertex v with in-degree one and obtain Dfrom D by removing the incoming arc at v. Now let μ 1 ≥…≥ μ n be the N-eigenvalues of D. Then,

λ 1 μ 1 λ 2 μ 2 λ n μ n .

Let us derive another N-eigenvalue interlacing theorem. To this end, let D = (V, E) be a digraph and IV. By D I (resp. D +I ) we denote the digraph obtained by adding a sink (resp. source) to the digraph D such that its set of in-neighbors (resp. out-neighbors) is I. Furthermore, let A I (resp. A +I ) denote the adjacency matrix of D I (resp. D +I ).

Theorem 7

Let D = (V, E) be a digraph and I = {i 1, i 2,…,i r } ⊂ V. Suppose that λ 1λ 2 ≥ … ≥ λ n are the N-eigenvalues of the digraph D and μ 1μ 2 ≥…≥ μ n+1 are the N-eigenvalues of D I (resp. D +I ). Then,

λ 1 + r μ 1 λ 1 μ 2 λ 2 λ n μ n + 1 = 0 .

Proof

In this proof and also later on we shall use subscripts of the form r × s to document the dimensions of some annotated matrix, in order to make the overall block structure more transparent. Moreover, if a mere number is affixed with such a dimensional annotation, then this denotes a matrix of the mentioned dimensions where all entries are equal to that number.

The adjacency matrix of D I is given by

A I = ( ( A ) n × n ( j = 1 r e i j ) n × 1 ( 0 ) 1 × n ( 0 ) 1 × 1 ) ,

where, as usual, e k denotes the kth unit vector (of the dimension implied by the context). Therefore,

( A I ) T ( A I ) = ( ( A T ) n × n ( 0 ) n × 1 ( j = 1 r e i j T ) 1 × n ( 0 ) 1 × 1 ) ( ( A ) n × n ( j = 1 r e i j ) n × 1 ( 0 ) 1 × n ( 0 ) 1 × 1 ) = ( ( A T A ) n × n ( A T j = 1 r e i j ) n × 1 ( j = 1 r e i j T A ) 1 × n ( r ) 1 × 1 ) .

Note that A T A is the principal submatrix of (A I ) T (A I ). Applying the interlacing Theorem 5 on (A I ) T (A I ) and using the fact that the matrices (A I ) T (A I ) and (A I )(A I ) T have the same spectra (and likewise AA T and A T A), we get

μ 1 λ 1 μ 2 λ 2 λ n μ n + 1 = 0 .

It remains to prove μ 1λ 1 + r. In order to do that consider

( A I ) ( A I ) T = ( ( A A T + j = 1 r e i j k = 1 r e i k T ) n × n ( 0 ) n × 1 ( 0 ) 1 × n ( 0 ) 1 × 1 ) .

Now observe j = 1 r e i j k = 1 r e i k T = [ b s t ] , where

b s t = { 1 s = i j and t = i k for some 1 j , k r , 0 otherwise .

This implies that j = 1 r e i j k = 1 r e i k T has a maximum row sum of r. Now, since (A I )(A I ) T is a positive semi-definite matrix, we have

μ 1 = A A T + j = 1 r e i j k = 1 r e i k T A A T + j = 1 r e i j k = 1 r e i k T = λ 1 + j = 1 r e i j k = 1 r e i k T λ 1 + j = 1 r e i j k = 1 r e i k T = λ 1 + r .

The proof for the case D +I works analogously.□

The effect of adding a vertex with both incoming and outgoing arcs on the entire N-spectrum can be hardly predicted. However, the following two theorems describe the effect of such an operation on the N-spectral radius of oriented digraphs.

Theorem 8

Let D = (V, E) be a digraph, I = { v i 1 , v i 2 , , v i r } V any set of source vertices in D and D ±I the digraph obtained from D by adding a new vertex η and connecting it to each vertex of I (with an arc of arbitrary orientation). Then,

λ 1 deg ( η ) μ 1 λ 1 + deg ( η ) ,

where λ 1 is the N-spectral radius of D and μ 1 is the N-spectral radius of D ±I .

Proof

Observe that η only gets connected to vertices that originally were sources, but some of the old source vertices contained in I may lose their source property in the new digraph. This needs to be analyzed. The adjacency matrix of D ±I is given by

A ± I = ( ( A ) n × n ( v i j N ( η ) e i j ) n × 1 ( v i j N + ( η ) e i j T ) 1 × n ( 0 ) 1 × 1 ) ,

so it follows that

A ± I ( A ± I ) T = ( P Q R S ) ,

where

P = ( A A T + v i j N ( η ) e i j v i j N ( η ) e i j T ) n × n Q = ( A v i j N + ( η ) e i j ) n × 1 R = Q T S = ( v i j N + ( η ) e i j T v i j N + ( η ) e i j ) 1 × 1 .

Note that Q describes the new common out-neighbors of the vertices in V with the vertex η. Since all vertices in I are source vertices in D, there is no new common out-neighbor between V and η in D ±I . Therefore, Q = (0) n×1, and by symmetry R = (0)n . Furthermore, the single entry in S is equal to deg(η), so

σ N ( D ± I ) = σ ( P ) { deg ( η ) } .

Using the interlacing Theorem 5, we therefore obtain

A ± I ( A ± I ) T = μ 1 A A T + v i j N ( η ) e i j v i j N ( η ) e i j T A A T v i j N ( η ) e i j v i j N ( η ) e i j T λ 1 v i j N ( η ) e i j v i j N ( η ) e i j T ,

but v i j N ( η ) e i j v i j N ( η ) e i j T is the matrix that describes the new common out-neighbors of the vertices of I. In fact, any two vertices in N(η) have common out-neighbors, therefore, the matrix v i j N ( η ) e i j v i j N ( η ) e i j T has a maximum row sum of deg(η). This implies λ 1 − deg(η) ≤ μ 1. The other inequality can be proved in the same way.□

Corollary 1

Let D be a digraph, I = { v i 1 , v i 2 , , v i r } V ( D ) any set of sink vertices in D and D ±I the digraph obtained from D by adding a new vertex η with incoming and outgoing arcs attached to the vertices in I. Then,

λ 1 deg + ( η ) μ 1 λ 1 + deg + ( η ) ,

where λ 1 is the N-spectral radius of D and μ 1 is the N-spectral radius of D ±I .

Corollary 2

Adding a new source (resp. sink) vertex to a digraph D attached to some source (resp. sink) vertices in D does not change the N-spectral radius.

Theorem 9

Let G = (V, E) be a graph and uV such that no two vertices in N(u) are adjacent. Furthermore, let D be an arbitrary orientation of G, as long as all vertices in N(u) become sinks (resp. sources) in Du and u becomes a sink (resp. source) in D. Then,

λ 1 ( G ) 2 μ 1 ( D u ) ,

where λ 1(G) denotes the largest eigenvalue of G and μ 1(Du) denotes the largest N-eigenvalue of Du.

Proof

Using Theorem 3, we get λ 1 ( G ) 2 μ 1 ( D ) . But Corollary 2 implies μ 1(D) = μ 1(Du), hence the proof is complete.□

References

[1] Lothar von Collatz and Ulrich Sinogowitz, Spektren endlicher grafen, Abh. Math. Semin. Univ. Hamb. 21 (1957), no. 1, 63–77.10.1007/BF02941924Search in Google Scholar

[2] Dragoš M. Cvetković and Ivan M. Gutman, The algebraic multiplicity of the number zero in the spectrum of a bipartite graph, Mat. Vesn. N. Ser. 9 (1972), 141–150.Search in Google Scholar

[3] Norman Biggs, Algebraic Graph Theory, 2nd ed., Cambridge University Press, Cambridge, 1994.Search in Google Scholar

[4] Andries E. Brouwer and Willem H. Haemers, Spectra of Graphs, Springer-Verlag, New York, 2012.10.1007/978-1-4614-1939-6Search in Google Scholar

[5] Chris Godsil and Gordon F. Royle, Algebraic Graph Theory, Springer-Verlag, New York, 2013.Search in Google Scholar

[6] László Lovász, On the Shannon capacity of a graph, IEEE Trans. Inf. Theory. 25 (1979), no. 1, 1–7.10.1109/TIT.1979.1055985Search in Google Scholar

[7] Bojan Mohar and Svatopluk Poljak, Eigenvalues in combinatorial optimization, in: R. A. Brualdi, S. Rriedland, V. Klee (eds.), Combinatorial and Graph-Theoretical Problems in Linear Algebra, The IMA Volumes in Mathematics and its Applications, vol. 50, Springer, New York, NY, 1993, pp. 107–151.10.1007/978-1-4613-8354-3_5Search in Google Scholar

[8] Uwe Naumann and Olaf Schenk, Combinatorial Scientific Computing, CRC Press, New York, 2012.10.1201/b11644Search in Google Scholar

[9] Krystal Guo and Bojan Mohar, Hermitian adjacency matrix of digraphs and mixed graphs, J. Graph Theory. 85 (2017), no. 1, 217–248, 10.1002/jgt.22057.Search in Google Scholar

[10] Irena M. Jovanović, Non-negative spectrum of a digraph, ARS Math. Contemp. 12 (2017), no. 1, 167–182, 10.26493/1855-3974.682.065.Search in Google Scholar

[11] Omar Alomari, Mohammad Abudayah, and Torsten Sander, The non-negative spectrum of a digraph, Open Math. 18 (2020), 22–35, 10.1515/math-2020-0005.Search in Google Scholar

[12] Dragiša Cvetković and Peter Rowlinson, The largest eigenvalue of a graph: a survey, Linear Multilinear Algebra 28 (1990), no. 1–2, 3–33.10.1080/03081089008818026Search in Google Scholar

[13] Dragan Stevanović, Spectral Radius of Graphs, Academic Press, Amsterdam, 2015.Search in Google Scholar

[14] Rajendra Bhatia and Fuad Kittaneh, On the singular values of a product of operators, SIAM J. Matrix Anal. Appl. 11 (1990), no. 2, 272–277.10.1137/0611018Search in Google Scholar

[15] Richard A. Brualdi and Ernie S. Solheid, On the spectral radius of connected graphs, Publ. Inst. Math. Nouv. Sér. 39 (1986), 45–54 (English).Search in Google Scholar

[16] Amitava Bhattacharya, Shmuel Friedland, and Uri N. Peled, On the first eigenvalue of bipartite graphs, Electron. J. Combin. 15 (2008), no. 1, R144, http://eudml.org/doc/117282.10.37236/868Search in Google Scholar

Received: 2019-07-28
Revised: 2020-03-10
Accepted: 2020-04-14
Published Online: 2020-06-04

© 2020 Mohammad Abudayah et al., published by De Gruyter

This work is licensed under the Creative Commons Attribution 4.0 International License.

Articles in the same Issue

  1. Regular Articles
  2. Non-occurrence of the Lavrentiev phenomenon for a class of convex nonautonomous Lagrangians
  3. Strong and weak convergence of Ishikawa iterations for best proximity pairs
  4. Curve and surface construction based on the generalized toric-Bernstein basis functions
  5. The non-negative spectrum of a digraph
  6. Bounds on F-index of tricyclic graphs with fixed pendant vertices
  7. Crank-Nicolson orthogonal spline collocation method combined with WSGI difference scheme for the two-dimensional time-fractional diffusion-wave equation
  8. Hardy’s inequalities and integral operators on Herz-Morrey spaces
  9. The 2-pebbling property of squares of paths and Graham’s conjecture
  10. Existence conditions for periodic solutions of second-order neutral delay differential equations with piecewise constant arguments
  11. Orthogonal polynomials for exponential weights x2α(1 – x2)2ρe–2Q(x) on [0, 1)
  12. Rough sets based on fuzzy ideals in distributive lattices
  13. On more general forms of proportional fractional operators
  14. The hyperbolic polygons of type (ϵ, n) and Möbius transformations
  15. Tripled best proximity point in complete metric spaces
  16. Metric completions, the Heine-Borel property, and approachability
  17. Functional identities on upper triangular matrix rings
  18. Uniqueness on entire functions and their nth order exact differences with two shared values
  19. The adaptive finite element method for the Steklov eigenvalue problem in inverse scattering
  20. Existence of a common solution to systems of integral equations via fixed point results
  21. Fixed point results for multivalued mappings of Ćirić type via F-contractions on quasi metric spaces
  22. Some inequalities on the spectral radius of nonnegative tensors
  23. Some results in cone metric spaces with applications in homotopy theory
  24. On the Malcev products of some classes of epigroups, I
  25. Self-injectivity of semigroup algebras
  26. Cauchy matrix and Liouville formula of quaternion impulsive dynamic equations on time scales
  27. On the symmetrized s-divergence
  28. On multivalued Suzuki-type θ-contractions and related applications
  29. Approximation operators based on preconcepts
  30. Two types of hypergeometric degenerate Cauchy numbers
  31. The molecular characterization of anisotropic Herz-type Hardy spaces with two variable exponents
  32. Discussions on the almost 𝒵-contraction
  33. On a predator-prey system interaction under fluctuating water level with nonselective harvesting
  34. On split involutive regular BiHom-Lie superalgebras
  35. Weighted CBMO estimates for commutators of matrix Hausdorff operator on the Heisenberg group
  36. Inverse Sturm-Liouville problem with analytical functions in the boundary condition
  37. The L-ordered L-semihypergroups
  38. Global structure of sign-changing solutions for discrete Dirichlet problems
  39. Analysis of F-contractions in function weighted metric spaces with an application
  40. On finite dual Cayley graphs
  41. Left and right inverse eigenpairs problem with a submatrix constraint for the generalized centrosymmetric matrix
  42. Controllability of fractional stochastic evolution equations with nonlocal conditions and noncompact semigroups
  43. Levinson-type inequalities via new Green functions and Montgomery identity
  44. The core inverse and constrained matrix approximation problem
  45. A pair of equations in unlike powers of primes and powers of 2
  46. Miscellaneous equalities for idempotent matrices with applications
  47. B-maximal commutators, commutators of B-singular integral operators and B-Riesz potentials on B-Morrey spaces
  48. Rate of convergence of uniform transport processes to a Brownian sheet
  49. Curves in the Lorentz-Minkowski plane with curvature depending on their position
  50. Sequential change-point detection in a multinomial logistic regression model
  51. Tiny zero-sum sequences over some special groups
  52. A boundedness result for Marcinkiewicz integral operator
  53. On a functional equation that has the quadratic-multiplicative property
  54. The spectrum generated by s-numbers and pre-quasi normed Orlicz-Cesáro mean sequence spaces
  55. Positive coincidence points for a class of nonlinear operators and their applications to matrix equations
  56. Asymptotic relations for the products of elements of some positive sequences
  57. Jordan {g,h}-derivations on triangular algebras
  58. A systolic inequality with remainder in the real projective plane
  59. A new characterization of L2(p2)
  60. Nonlinear boundary value problems for mixed-type fractional equations and Ulam-Hyers stability
  61. Asymptotic normality and mean consistency of LS estimators in the errors-in-variables model with dependent errors
  62. Some non-commuting solutions of the Yang-Baxter-like matrix equation
  63. General (p,q)-mixed projection bodies
  64. An extension of the method of brackets. Part 2
  65. A new approach in the context of ordered incomplete partial b-metric spaces
  66. Sharper existence and uniqueness results for solutions to fourth-order boundary value problems and elastic beam analysis
  67. Remark on subgroup intersection graph of finite abelian groups
  68. Detectable sensation of a stochastic smoking model
  69. Almost Kenmotsu 3-h-manifolds with transversely Killing-type Ricci operators
  70. Some inequalities for star duality of the radial Blaschke-Minkowski homomorphisms
  71. Results on nonlocal stochastic integro-differential equations driven by a fractional Brownian motion
  72. On surrounding quasi-contractions on non-triangular metric spaces
  73. SEMT valuation and strength of subdivided star of K 1,4
  74. Weak solutions and optimal controls of stochastic fractional reaction-diffusion systems
  75. Gradient estimates for a weighted nonlinear parabolic equation and applications
  76. On the equivalence of three-dimensional differential systems
  77. Free nonunitary Rota-Baxter family algebras and typed leaf-spaced decorated planar rooted forests
  78. The prime and maximal spectra and the reticulation of residuated lattices with applications to De Morgan residuated lattices
  79. Explicit determinantal formula for a class of banded matrices
  80. Dynamics of a diffusive delayed competition and cooperation system
  81. Error term of the mean value theorem for binary Egyptian fractions
  82. The integral part of a nonlinear form with a square, a cube and a biquadrate
  83. Meromorphic solutions of certain nonlinear difference equations
  84. Characterizations for the potential operators on Carleson curves in local generalized Morrey spaces
  85. Some integral curves with a new frame
  86. Meromorphic exact solutions of the (2 + 1)-dimensional generalized Calogero-Bogoyavlenskii-Schiff equation
  87. Towards a homological generalization of the direct summand theorem
  88. A standard form in (some) free fields: How to construct minimal linear representations
  89. On the determination of the number of positive and negative polynomial zeros and their isolation
  90. Perturbation of the one-dimensional time-independent Schrödinger equation with a rectangular potential barrier
  91. Simply connected topological spaces of weighted composition operators
  92. Generalized derivatives and optimization problems for n-dimensional fuzzy-number-valued functions
  93. A study of uniformities on the space of uniformly continuous mappings
  94. The strong nil-cleanness of semigroup rings
  95. On an equivalence between regular ordered Γ-semigroups and regular ordered semigroups
  96. Evolution of the first eigenvalue of the Laplace operator and the p-Laplace operator under a forced mean curvature flow
  97. Noetherian properties in composite generalized power series rings
  98. Inequalities for the generalized trigonometric and hyperbolic functions
  99. Blow-up analyses in nonlocal reaction diffusion equations with time-dependent coefficients under Neumann boundary conditions
  100. A new characterization of a proper type B semigroup
  101. Constructions of pseudorandom binary lattices using cyclotomic classes in finite fields
  102. Estimates of entropy numbers in probabilistic setting
  103. Ramsey numbers of partial order graphs (comparability graphs) and implications in ring theory
  104. S-shaped connected component of positive solutions for second-order discrete Neumann boundary value problems
  105. The logarithmic mean of two convex functionals
  106. A modified Tikhonov regularization method based on Hermite expansion for solving the Cauchy problem of the Laplace equation
  107. Approximation properties of tensor norms and operator ideals for Banach spaces
  108. A multi-power and multi-splitting inner-outer iteration for PageRank computation
  109. The edge-regular complete maps
  110. Ramanujan’s function k(τ)=r(τ)r2(2τ) and its modularity
  111. Finite groups with some weakly pronormal subgroups
  112. A new refinement of Jensen’s inequality with applications in information theory
  113. Skew-symmetric and essentially unitary operators via Berezin symbols
  114. The limit Riemann solutions to nonisentropic Chaplygin Euler equations
  115. On singularities of real algebraic sets and applications to kinematics
  116. Results on analytic functions defined by Laplace-Stieltjes transforms with perfect ϕ-type
  117. New (p, q)-estimates for different types of integral inequalities via (α, m)-convex mappings
  118. Boundary value problems of Hilfer-type fractional integro-differential equations and inclusions with nonlocal integro-multipoint boundary conditions
  119. Boundary layer analysis for a 2-D Keller-Segel model
  120. On some extensions of Gauss’ work and applications
  121. A study on strongly convex hyper S-subposets in hyper S-posets
  122. On the Gevrey ultradifferentiability of weak solutions of an abstract evolution equation with a scalar type spectral operator on the real axis
  123. Special Issue on Graph Theory (GWGT 2019), Part II
  124. On applications of bipartite graph associated with algebraic structures
  125. Further new results on strong resolving partitions for graphs
  126. The second out-neighborhood for local tournaments
  127. On the N-spectrum of oriented graphs
  128. The H-force sets of the graphs satisfying the condition of Ore’s theorem
  129. Bipartite graphs with close domination and k-domination numbers
  130. On the sandpile model of modified wheels II
  131. Connected even factors in k-tree
  132. On triangular matroids induced by n3-configurations
  133. The domination number of round digraphs
  134. Special Issue on Variational/Hemivariational Inequalities
  135. A new blow-up criterion for the Nabc family of Camassa-Holm type equation with both dissipation and dispersion
  136. On the finite approximate controllability for Hilfer fractional evolution systems with nonlocal conditions
  137. On the well-posedness of differential quasi-variational-hemivariational inequalities
  138. An efficient approach for the numerical solution of fifth-order KdV equations
  139. Generalized fractional integral inequalities of Hermite-Hadamard-type for a convex function
  140. Karush-Kuhn-Tucker optimality conditions for a class of robust optimization problems with an interval-valued objective function
  141. An equivalent quasinorm for the Lipschitz space of noncommutative martingales
  142. Optimal control of a viscous generalized θ-type dispersive equation with weak dissipation
  143. Special Issue on Problems, Methods and Applications of Nonlinear analysis
  144. Generalized Picone inequalities and their applications to (p,q)-Laplace equations
  145. Positive solutions for parametric (p(z),q(z))-equations
  146. Revisiting the sub- and super-solution method for the classical radial solutions of the mean curvature equation
  147. (p,Q) systems with critical singular exponential nonlinearities in the Heisenberg group
  148. Quasilinear Dirichlet problems with competing operators and convection
  149. Hyers-Ulam-Rassias stability of (m, n)-Jordan derivations
  150. Special Issue on Evolution Equations, Theory and Applications
  151. Instantaneous blow-up of solutions to the Cauchy problem for the fractional Khokhlov-Zabolotskaya equation
  152. Three classes of decomposable distributions
Downloaded on 8.10.2025 from https://www.degruyterbrill.com/document/doi/10.1515/math-2020-0167/html?lang=en&srsltid=AfmBOoru5-LN3EtOUEe7MgIHw1AjlfSDlbYbYGsLwtX2I2MfmDhhBiCL
Scroll to top button