THE EFFICIENT EVALUATION OF THE HYPERGEOMETRIC FUNCTION OF A MATRIX ARGUMENT

Size: px
Start display at page:

Download "THE EFFICIENT EVALUATION OF THE HYPERGEOMETRIC FUNCTION OF A MATRIX ARGUMENT"

Transcription

1 MATHEMATICS OF COMPUTATION Volume 75, Number 54, Pages S (6)184- Article electronically published on January 19, 6 THE EFFICIENT EVALUATION OF THE HYPERGEOMETRIC FUNCTION OF A MATRIX ARGUMENT PLAMEN KOEV AND ALAN EDELMAN Abstract. We present new algorithms that efficiently approimate the hypergeometric function of a matri argument through its epansion as a series of Jack functions. Our algorithms eploit the combinatorial properties of the Jack function, and have compleity that is only linear in the size of the matri. 1. Introduction The hypergeometric function of a matri argument has a wide area of applications in multivariate statistical analysis [17], random matri theory [7], wireless communications [8], [1], etc. Ecept in a few special cases, it can be epressed only as a series of multivariate homogeneous polynomials, called Jack functions. This series often converges very slowly [16, p. 39], [17], and the cost of the straightforward evaluation of a single Jack function is eponential [3]. The hypergeometric function of a matri argument has thus acquired a reputation of being notoriously difficult to approimate even in the simplest cases [], [1]. In this paper we present new algorithms for approimating the value of the hypergeometric function of a matri argument. We eploit recursive combinatorial relationships between the Jack functions, which allow us to only update the value of a Jack function from other Jack functions computed earlier in the series. The savings in computational time are enormous; the resulting algorithm has compleity that is only linear in the size of the matri argument. In the special case when the matri argument is a multiple of the identity, the evaluation becomes even faster. We have made a MATLAB [15] implementation of our algorithms available [13]. This implementation is very efficient (see performance results in Section 6), and has lead to new results [1], [6]. The hypergeometric function of a matri argument is defined as follows. Let p andq be integers, and let X be an n n comple symmetric matri with eigenvalues 1,,..., n.then (1.1) p F (a q 1 ) (a p ) (a 1,...,a p ; b 1,...,b q ; X) C k!(b 1 ) (b q ) (X), k= k Received by the editor September 16, 4 and, in revised form, February 6, 5. Mathematics Subject Classification. Primary 33C, 65B1; Secondary 5A99. Key words and phrases. Hypergeometric function of a matri argument, Jack function, zonal polynomial, eigenvalues of random matrices. This work was supported in part by NSF Grant DMS c 6 American Mathematical Society

2 834 PLAMEN KOEV AND ALAN EDELMAN where α> is a parameter, k means =( 1,,...) is a partition of k (i.e., 1 are integers such that = k), (1.) (a) ( a i 1 ) α + j 1 (i,j) is the generalized Pochhammer symbol, andc (X) is the Jack function. The Jack function C (X) =C ( 1,,..., n ) is a symmetric, homogeneous polynomial of degree in the eigenvalues 1,,..., n of X [17, Rem., p. 8], []. For eample, when α =1,C (X) becomes the (normalized) Schur function, and for α =,thezonal polynomial. 1 There are several normalizations of the Jack function which are scalar multiples of one another: C (X) is normalized so that k C (X) = (tr X) k ; in Section 3 we epress (1.1) in terms of the Jack function (X), which is normalized so that the coefficient of 1 is ( )!. The functions C (X) andj (X) can be defined recursively, e.g., J (1.3) J ( 1,,..., n )= J µ ( 1,,..., n 1 ) /µ n β µ, µ where β µ is a rational function of α (see Section 3 for details). The relationship (1.3) becomes key in achieving efficiency in our algorithms. The Jack functions C (X) andj (X), and in turn the hypergeometric function of a matri argument, depend only on the eigenvalues 1,,..., n of X. Many authors, however, have found the matri notation in (1.1) and the use of a matri argument to be more convenient. We follow the same practice. The hypergeometric function of a matri argument is scalar-valued, which is a major distinction from other functions of a matri argument (e.g., the matri eponential), which are matri-valued. The hypergeometric function of a matri argument generalizes the classical hypergeometric function to which it reduces for n = 1. In general, however, there is no eplicit relationship between these two functions for n. We approimate the series (1.1) by computing its truncation for m: (1.4) m p F q (a 1,...,a p ; b 1,...,b q ; X) m k= k (a 1 ) (a p ) k!(b 1 ) (b q ) C (X). The series (1.1) converges for any X when p q; itconvergesifma i i < 1 when p = q + 1, and diverges when p>q+ 1, unless it terminates [17, p. 58]. When it converges, its -term converges to zero as. In these cases (1.4) is a good approimation to (1.1) for a large enough m. The computational difficulties in evaluating (1.4) are: (A) the series (1.1) converges slowly in many cases [16]; thus a rather large m may be needed before (1.4) becomes a good approimation to (1.1); (B) the number of terms in (1.4) (i.e., the number of partitions m) grows, roughly, as O(e m ) (see Section 5); (C) the straightforward evaluation of a single Jack function, C (X) for = m, has compleity that grows as O(n m )[3]. 1 Some authors define the hypergeometric function of a matri argument through the series (1.1) for α =1[9,(4.1)]orα = [17, p. 58] only. There is no reason for us to treat the different α s separately (see also [4], [5], [7] for the uniform treatment of the different α s in other settings).

3 HYPERGEOMETRIC FUNCTION OF A MATRIX ARGUMENT 835 While there is little we can do about (A) (which is also a major problem even in the univariate (n = 1) case [18]) or (B), our major contribution is in improving (C), the cost of evaluating the Jack function. We eploit the combinatorial properties of the Pochhammer symbol and the Jack function to only update the -term in (1.4) from the µ-terms, µ. As a result the compleity of our main algorithm for computing (1.4), Algorithm 4., is only linear in the size n of the matri argument X, eponentially faster than the previous best algorithm [1] (see Sections, 5 and 6.3 for details). In the special case when X is a multiple of the identity, we present an even faster algorithm, Algorithm 4.1, whose compleity is independent of n. A number of interesting problems remain open. Among these are: detecting convergence; selecting the optimal value of m in (1.4) for a desired accuracy; selecting the optimal truncation of the series (1.1). We do not believe that a uniform answer to these problems eists for every α and every p and q. Therefore, we leave the choice of m and an appropriate truncation to the user. We elaborate more on these open problems in Section 7. With minimal changes our algorithms can approimate the hypergeometric function of two matri arguments (1.5) pf q (a 1:p ; b 1:q ; X, Y ) k= k and more generally functions of the form (1.6) G(X) = k= k (a 1 ) (a p ) k!(b 1 ) (b q ) a C (X), C (X) C C (I) (Y ), for arbitrary coefficients a at a similar computational cost (see, e.g., (6.5) in subsection 6.). In (1.5) and throughout this paper, we denote a vector (z 1,...,z t )asz 1:t. This paper is organized as follows. We survey previous algorithms for computing the hypergeometric function of a matri argument in Section. In Section 3 we describe our approach in computing the truncation (1.4). We present our new algorithms in Section 4, and analyze their compleity in Section 5. We present numerical eperiments in Section 6. Finally, we draw conclusions and present open problems in Section 7.. Previous algorithms Butler and Wood [] used Laplace approimations to compute the integral representations [17, Thm. 7.4., p. 64]: 1 (a; c; X) = Γ () n (c) Γ () n (a)γ () n (c a) 1F () <Y <I e tr(xy ) n+1 a (det Y ) n+1 c a det(i Y ) (dy ),

4 836 PLAMEN KOEV AND ALAN EDELMAN valid for real symmetric X, R(a) > n 1 1 (a, b; c; X) = Γ () n (c) F () n 1, R(c) > Γ () n (a)γ () n (c a) <Y <I,andR(c a) > n 1 ;and det(i XY ) b n+1 n+1 a (det Y ) c a det(i Y ) (dy ), valid for R(X) <I, R(a) > n 1 n 1,andR(c a) >. This approach, however, is restricted to the cases p = 1 or, q =1,andα =. Gutiérrez, Rodriguez, and Sáez presented in [1] (see also [19] for the implementation) an algorithm for computing the truncation (1.4) for α = (then the Jack functions are called zonal polynomials). For every k = 1,,..., m, the authors form the upper triangular transition matri [14, p. 99] K (indeed by all partitions of k) between the monomial symmetric functions (m ) k and the zonal polynomials (C ) k. Then for every partition =( 1,,...) k they compute m = µ µ 1 1 µ (where µ ranges over all distinct permutations of ( 1,,...) [, p. 89]) and form the product (C ) k = K (m ) k. Computing the vector (m ) m alone costs m ( ) n+m 1 m = O(n m ) since every term in every m is of degree m, andforevery nonstrictly increasing sequence of m numbers from the set {1,,..., n} we obtain adistinctterminsomem. The overall cost is thus at least eponential (O(n m )), which eplains the authors observation: We spent about 8 days to obtain the 67 zonal polynomials of degree with a 35 MHz Pentium II processor. In contrast, our Algorithm 4. takes less than a hundredth of a second to do the same. Its compleity is only linear in n and subeponential in m (see Section 5). 3. Our approach We make the evaluation of m p F q (a 1:p ; b 1:q ; X) efficient by only updating the -term from the µ-terms, µ, instead of computing it from scratch. We first epress m p F q (a 1:p ; b 1:q ; X) in terms of the Jack function J (X), which is normalized so that the coefficient of 1 in J (X) =J ( 1,,..., n ) equals ( )! [, Thm. 1.1]. The Jack functions C (X) andj (X) are related as (3.1) C where (3.) j = (X) = α ( )! (i,j) j J (X), h (i, j)h (i, j), and h (i, j) j i + α( i j +1)andh (i, j) j i +1+α( i j) arethe upper and lower hook lengths at (i, j), respectively. Denote (3.3) Q α (a 1 ) (a p ) j (b 1 ) (b q ).

5 HYPERGEOMETRIC FUNCTION OF A MATRIX ARGUMENT 837 Since J (X) =when n+1 >, we need to sum only over partitions with at most n parts: (3.4) m p F q (a 1:p ; b 1:q ; X) = m, n+1 = Q J (X). When computing (3.4), we recursively generate all partitions m in such a way that consecutively generated partitions differ in only one part. Therefore it is convenient to introduce the notation (i) ( 1,..., i 1, i 1, i+1,...) for any partition such that i > i+1. In the following subsections we derive formulas for updating the -term in (3.4) from the µ-terms, µ Updating the coefficients Q. We update Q from Q (i) using the following lemma. Lemma 3.1. (3.5) p Q j=1 = (a j + c) i 1 Q q (i) j=1 (b j + c) (g j α)e j g j=1 j (e j + α) i 1 j=1 l j f j l j + h j, where c = i 1 α + i 1, d = i α i, e j = d jα + j, g j = e j +1, f j = j α j d, h j = f j + α, andl j = h j f j. Proof. From (1.), (a) j (i) (3.6) = 1 i 1 j α h (i) (i, j) h (i) (i, j) h j=1 (i, j) h (i, j) which along with (3.3) imply (3.5). =(a) (i) (a (i 1)/α + i 1), and from (3.), i 1 j=1 h (i) (j, i ) h (i) (j, i ) h (j, i ) h, (j, i ) The seemingly complicated notation of Lemma 3.1 is needed in order to minimize the number of arithmetic operations needed to update Q. A straightforward evaluation of (3.3) costs 6 (+p+q); in contrast, (3.5) costs only (p+q)+1 i +9i 11 arithmetic operations. 3.. Updating the Jack function. When =(),J () ( 1,..., n )=1. For >(), we update J ( 1,..., n )fromj µ ( 1,..., r ),µ, r n. When X is a multiple of the identity we have an easy special case [, Thm. 5.4]: J (I) = (n (i 1) + α(j 1)). (i,j) Therefore we can update J (I) fromj (i) (I) as (3.7) J (I) =J (i) (I) (n i +1+α( i 1)). In the general case, we update the Jack function using the identity (see, e.g., [, Prop. 4.]), (3.8) J ( 1,,..., n )= J µ ( 1,,..., n 1 ) /µ n β µ, µ

6 838 PLAMEN KOEV AND ALAN EDELMAN where the summation is over all µ such that /µ is a horizontal strip, and { (i,j) (3.9) β µ B µ(i, j) h (i,j) µ Bµ µ(i, j), where Bν µ(i, j) ν (i, j), if j = µ j, h ν (i, j), otherwise. The skew partition /µ is a horizontal strip when 1 µ 1 µ [, p. 339]. We borrow the idea for updating the Jack function from [3], but make two important improvements. We only update the coefficients β µ, and store the precomputed Jack functions much more efficiently than in [3]. The coefficients β µ are readily computable using (3.9) at the cost of 6( + µ ) arithmetic operations. The following lemma allows us to start with β =1and update β µ(k) from β µ at the cost of only 1k +6µ k 7 arithmetic operations. Lemma 3.. Let, µ, and ν = µ (k) be partitions such that /µ and /ν are horizontal strips, and r = µ r for r k 1. Then β ν k k 1 u r (3.1) = α β µ u r=1 r + α µ v r + α k 1 w r + α, v r=1 r w r=1 r where α = α 1, t= k αµ k,q= t +1,u r = q r + α r,v r = t r + αµ r,and w r = µ r t αr. Proof. Denote l µ k.wehaveν = µ, ecept for ν k = µ k 1. Since /µ and /ν are horizontal strips, l = µ l and l ν l = µ l 1. Then β ν µ = Bµ µ B ν β µ B µ ν Bν ν = Bν Bµ ν B µ µ B ν ν B µ µ(k, l) = Bν B B µ µ (3.11) µ B ν α. ν ν We transform the first term of (3.11) by observing that Bµ(i, j) =Bν(i, j), ecept for j = l: k k k Bν B B = ν(r, l) µ B r=1 µ(r, l) = h (r, l) h r=1 (r, l) = k r +1+α( r l) k r + α( r=1 r l +1). To simplify the second term of (3.11), we observe that B µ(i, µ j) =Bν(i, ν j), ecept for i = k and j = l. Also r = µ r = ν r for r k 1, and k = µ k µ k 1=ν k. Therefore ν B µ µ B ν ν = = = which yields (3.1). k r=1 l 1 r=1 l 1 r=1 B µ µ(r, l) B ν ν(r, l) l B µ(k, µ r) r=1 B ν ν(k, r) h k 1 µ(k, r) h ν(k, r) h µ(r, l) h ν r=1 (r, l) µ r k + α(µ k r +1) µ r k + α(µ k r) k 1 r=1 k r + α(µ r l +1), k r + α(µ r l)

7 HYPERGEOMETRIC FUNCTION OF A MATRIX ARGUMENT Algorithms for efficient evaluation of m p F q (a 1:p ; b 1:q ; X) Algorithm 4.1 computes m p F q (a 1:p ; b 1:q ; X) in the easy special case when X is a multiple of the identity. Algorithm 4. handles the general case. Both algorithms recursively generate all partitions m with at most n parts by allowing 1 to take all values 1,,...,m and, independently, i,i =1,,...,n, to take all values 1,,..., i 1, subject to the restriction m. The coefficients Q are updated using (3.5). The Jack functions are updated using (3.7) or (3.8) as appropriate ThecasewhenX is a multiple of the identity. Algorithm 4.1 (Hypergeometric function, X = I). The following algorithm computes m p F q (a 1:p ; b 1:q ; I). The variables, n, α, s, a, b, and are global. function s = hgi(m, α, a, b, n, ) s =1 summation(1, 1, m) function summation(i, z, j) for i =1:min( i 1,j) (defaults to j for i =1) z = z (n i +1+α( i 1)) T (where T is the right-hand side of (3.5)) s = s + z if (j > i ) and (i <n) then summation(i +1,z,j i ) endif endfor i = In Algorithm 4.1 the variable z equals the -term in (3.4); it is updated using (3.5) and (3.7). The parameter j in summation equals m. The hypergeometric function of two matri arguments (1.5) is in this case pf q (a 1:p ; b 1:q ; I, yi) = p F q (a 1:p ; b 1:q ; yi). 4.. The general case. We use the identity (3.8) to update the Jack function, but in order to use it efficiently, we need to store and reuse the Jack functions computed earlier. Therefore we inde all partitions m with at most n parts ( n+1 =)by linearizing the m-tree that they form (each node =( 1,,..., k ) has at most m children ( 1,,..., k, k+1 ), k+1 =1,,...,min( k,m ), k < n). In other words, if P mn =#{ m, n+1 =}, we assign a distinct integer inde N {, 1,...,P mn } to every such partition. We start by assigning the indees, 1,...,m to partitions with one part: N (i) i, i =, 1,,...,m. Then, recursively, once an inde N has been assigned to a partition =( 1,..., k ) with k parts, we assign m consecutive unassigned indees to the partitions ( 1,..., k, k+1 ), k+1 =1,,...,m. We record the tree structure in an array D such that D(N (1,..., k ))=N (1,..., k,1). Now given, we can compute N by starting with N (1 ) = 1 and using the recurrence (4.1) N (1,..., i ) = D(N (1,..., i 1 ))+ i 1. We store every computed J ( 1:i )( m, n+1 =,i =1,,...,n)inthe (N,i)th entry of an P mn n array, which we call J in Algorithm 4. below.

8 84 PLAMEN KOEV AND ALAN EDELMAN We compute the value of P mn as follows. Let p k (i) be the number of partitions of i with eactly k parts. The p k (i),i =1,,...,m,k =1,,...,min(m, n), are computed using the recurrence p k (i) =p k 1 (i 1) + p k (i k) [1, p. 8]. Then (4.) P mn = m i=1 Net, we present our main algorithm. min(m,n) k=1 p k (i). Algorithm 4. (Hypergeometric function). The following algorithm computes m p F q (a 1:p ; b 1:q ; X), where X = diag(). The variables m, n, a, b, α,, J, D, H,, N,µ,N µ,ands are global. function s = hg(m, α, a, b, ) Compute P mn using (4.) n = length(); H = m +1; s =1; D = zeros(p mn, 1) J = zeros(p mn,n); J(1, :) = 1 (J ( 1:i ) is stored in J(N,i)) summation(1, 1, 1, m) function summation(i, z, j) r =min( i 1,j) (defaults to j for i =1) for i =1:r if ( i =1) and (i >1) then D(N )=H; N = H; H = H + r else N = N +1 endif z = z T (where T is the right-hand side of (3.5)) if 1 =1 then J(N, 1) = 1 (1 + α( 1 1)) J(N 1, 1) endif for t =:n do jack(, 1,,t) endfor s = s + z J(N,n,1) if (j > i ) and (i <n) then summation(i +1,z,j i ) endif endfor function jack(k, β µ,c,t) for i = k : µ 1 if (k >) and (µ i >µ i+1 ) d = N µ µ i = µ i 1; Compute N µ using (4.1) Update β µ using (3.1) if µ i > then jack(i, β µ,c+1,t) else J(N,t)=J(N,t)+β µ J(N µ,t 1) c+1 t endif µ i = µ i +1; N µ = d endif endfor if k = then J(N,t)=J(N,t)+J(N,t 1) else J(N,t)=J(N,t)+β µ c t endif (computes J ( 1:t ))

9 HYPERGEOMETRIC FUNCTION OF A MATRIX ARGUMENT 841 Algorithm 4. generates all partitions m with at most n parts analogously to Algorithm 4.1. The parameter z in summation is now just Q. For every the function jack recursively generates all partitions µ such that /µ is a horizontal strip. The Jack function is computed using (3.8); β µ is updated using (3.1). The parameter c equals µ at all times Implementation notes. In our implementation of Algorithms 4.1 and 4. in [13] we made a few fairly straightforward, but important improvements: (1) we precompute the values of j i for i =1,,...,n,andj =1,,...,m; () we keep and update the conjugate partitions and µ along with and µ, so we never need to recover and µ when computing (3.5) and (3.1); (3) when two sets of arguments ( 1:n and y 1:n ) are passed, the hypergeometric function of two matri arguments, (1.5), is computed; (4) if a vector = (t 1,...,t r ) is passed as a parameter in Algorithm 4.1, the output is also a vector with the values of m p F q (a 1:p ; b 1:q ; t j I)forj = 1,,...,r. 5. Compleity analysis Algorithm 4.1 (the case X = I) costso(p mn ) arithmetic operations (where again, P mn is the number of partitions, m with at most n parts). To bound the compleity of Algorithm 4. (general case) we observe that the formula (3.8) represents the summation of at most P mn terms (in fact a lot less, but we have been unable to obtain a better bound than P mn that is easy to work with). We use (3.8) to compute the Jack function J ( 1:t ) for all m and t n, i.e., P mn n Jack functions, each of which costs at most O(P mn ) arithmetic operations. The overall cost of Algorithm 4. is thus bounded by O(P mn n). There is no eplicit formula for P mn, so we use Ramanujan s asymptotic formula [11, p. 116] for number of partitions of m p(m) 1 4m 3 ep ( π m/3 ) to obtain P mn m i=1 ( p(i) O ep ( π m/3 )) ( and Pmn O ep ( π m/3 )). Therefore the compleity of Algorithm 4. is linear in n and subeponential in m. 6. Numerical eperiments We performed etensive numerical tests to verify the correctness and compleity of our Algorithms 4.1 and 4.. We compared the output of our algorithms for F and 1 F 1 with eplicit epressions (subsection 6.1). We also compared the probability distributions of the eigenvalues of certain random matrices (which are epressed as hypergeometric functions) against the results of Monte Carlo eperiments (subsection 6.). Finally, we present performance results in subsection 6.3.

10 84 PLAMEN KOEV AND ALAN EDELMAN 6.1. Eplicit epressions. We compared the output of Algorithms 4.1 and 4. against the epressions [17, p. 6]: (6.1) F (X) = e tr X, (6.) 1F (a; X) = det(i X) a, for n = 1 and random uniformly distributed values i [, 1 ], i =1,,...,n.For m = 3 it took less than one second per test. The results agreed to at least 1 decimal digits with (6.1), and at least 8 decimal digits with (6.), reflecting the slower convergence of (6.). 6.. Eigenvalue statistics. We tested Algorithms 4.1 and 4. against the eigenvalue statistics of the β-laguerre and Wishart matrices. The n nβ-laguerre matri of parameter a is defined as L = BB T,where B = χ a χ β(n 1) χ a β χ β χ a β(n 1), a > β (n 1). The n n Wishart matri with l degrees of freedom (l >n) and covariance matri Σ, A = W n (l, Σ), is defined as A =Σ 1/ Z T Z Σ 1/,whereZ ij = N(, 1) for i =1,,...,l; j =1,,...,n. The eigenvalue distributions of A and L are the same when β =1, a = l,and Σ=I. The cumulative distribution functions of the largest eigenvalues, λ L and λ A,of L and A, are ( Γ n 1 n α P (λ L <) = +1) ( ( Γ n a + n 1 α +1) ( n+1 ) P (λ A <) = Γ() n Γ () n ( l+n+1 ) det ( 1 Σ 1) l/ ) an ( 1F 1 a; a + n 1 α +1; 1 I), ( 1F () l 1 ; n+l+1 ; 1 Σ 1), respectively [4, Thm. 1..1, p. 147], [17, Thm , p. 4], where α =/β, and Γ n is the multivariate Gamma function of parameter α: n ( (6.3) Γ n (c) π n(n 1) α Γ c i 1 ) for R(c) > n 1 α α. i=1 We use the Kummer relation [17, Thm , p. 65] 1F 1 (a; c; X) =e tr X 1F 1 (c a; c; X) to obtain the equivalent, but numerically more stable epressions P (λ L <)= P (λ A <)= ( n 1 Γ n Γ n α ( +1) ( ) an a + n 1 e n α +1) ) ( n+1 Γ() n ( Γ () l+n+1 n 1F 1 ( n 1 α ) det ( 1 Σ 1) l/ e tr( Σ 1 ) 1 F () 1 n 1 +1;a + α +1;1 I), ( n+1 ; n+l+1 ; 1 Σ 1), which we plot on Figure 1 along with the Monte Carlo results from a sample of 1 random matrices.

11 HYPERGEOMETRIC FUNCTION OF A MATRIX ARGUMENT 843 cdf of λ ma of 3 3 Laguerre, a=3 cdf of λ ma of Laguerre, a= predicted eperimental cdf of λ ma of W (4,diag(1,)). predicted eperimental predicted eperimental cdf of λ ma of W 3 (4,diag(.5,1,1.1)). predicted eperimental 1 3 Figure 1. The c.d.f. of λ ma of the β-laguerre matri (top plots) and the Wishart matri (bottom plots). Net we consider the distribution of the smallest eigenvalue of L and that of tr A. If c = a β (n 1) 1 is a nonnegative integer, then the probability density function of the smallest eigenvalue of L (see, e.g., [4, Thm , p. 146]) is proportional to (6.4) f() = cn e ( n F (/β) c, β n +1; I n 1). Since c is a nonpositive integer, the series epansion of F (/β) in (6.4) terminates, even though it diverges in general. The probability density function of tr A is g f() = det(λ 1 Σ) l/ ln +k,λ() ( l () k! ) C() (I λσ 1 ) (6.5) where k= = det(λ 1 Σ) l/ k= k g ln +k,λ() k ( l ) () g r,λ () = e /λ r 1 (λ) r, ( >), Γ(r) k j 1 J () (I λσ 1 ),

12 844 PLAMEN KOEV AND ALAN EDELMAN.5 pdf of λ min of Laguerre, a=5.5 pdf of λ min of Laguerre, a= pdf of tr(a), A=W 3 (4,diag(.5,.5,1)) pdf of tr(a), A=W 4 (5,diag(.5,1,1.1,)) Figure. The p.d.f. of λ min of the β-laguerre matri (top plots) and the p.d.f. of the trace of the Wishart matri (bottom plots). and λ is arbitrary [17, p. 341]. We follow the suggestion by Muirhead to use λ =λ 1 λ l /(λ 1 + λ l ), where λ 1 and λ l are the largest and smallest eigenvalues of Σ, respectively. Although the epression (6.5) is not a hypergeometric function of a matri argument, its truncation for m has the form (1.6), and is computed analogously. We plot (6.4) and (6.5) on Figure and compare the theoretical predictions of these formulas with eperimental data Performance results. In Figure 3 we demonstrate the efficiency of Algorithms 4.1 and 4. on an 1.8GHz Intel Pentium 4 machine. In the left plot we present the performance data for Algorithm 4.1 (whose compleity is independent of the size n of the matri X = I). Its efficiency is evident we need to sum beyond partitions of size m = 5 before this algorithm takes a full second (for reference, the k! in the denominator of the -term in (1.1) then reaches up to 5! ). Algorithm 4. is also very efficient. The right plot of Figure 3 clearly demonstrates its linear compleity in n. It also takes at most a few seconds on matrices of size n 1 and partitions of size m 3.

13 HYPERGEOMETRIC FUNCTION OF A MATRIX ARGUMENT 845 Time to compute m F () (I n ) 5 Time to compute m F () (X) m=3 m=5 m= time in seconds time in seconds ma size partition m 5 1 n = size of X Figure 3. The performance of Algorithms 4.1 (left) and 4. (right). 7. Conclusions and open problems We have presented new algorithms for computing the truncation of the hypergeometric function of a matri argument. They eploit the combinatorial properties of the Pochhammer symbol and the Jack function to achieve remarkable efficiency, and have lead to new results [1], [6]. Several problems remain open, among them automatic detection of convergence. The -term in (3.4) does approach zero as, but it need not monotonically decrease. Although we have i 1 j=1 in (3.5), it is not always true that Q J i 1 (g j α)e j g j (e j + α) l j f j < 1 l j=1 j + h j Q (i) J (i), and it is unclear how to tell when convergence sets in. Another open problem is to determine the best way to truncate the series (1.1). Our choice to truncate it for m seems to work well in practice, but one can imagine selecting a partition λ and truncating for λ instead of, or in addition to m. Acknowledgments We thank Brian Sutton and Per-Olof Persson for several discussions that resulted in the simplification of the implementation of our algorithms, as well as the

14 846 PLAMEN KOEV AND ALAN EDELMAN anonymous referee for the useful comments, which lead to improvements in the eposition. References 1. P.-A. Absil, A. Edelman, and P. Koev, On the largest principal angle between random subspaces, Linear Algebra Appl., to appear.. R. W. Butler and A. T. A. Wood, Laplace approimations for hypergeometric functions with matri argument, Ann. Statist. 3 (), no. 4, MR19617 (3h:676) 3. J. Demmel and P. Koev, Accurate and efficient evaluation of Schur and Jack functions, Math. Comp., 75 (5), no. 53, I. Dumitriu, Eigenvalue statistics for the Beta-ensembles, Ph.D. thesis, Massachusetts Institute of Technology, I. Dumitriu and A. Edelman, Matri models for beta ensembles, J.Math.Phys.43 (), no. 11, MR (4g:844) 6. A. Edelman and B. Sutton, Tails of condition number distributions, SIAMJ.MatriAnal. Appl., accepted for publication, P. Forrester, Log-gases and random matrices, matpjf.html 8. H. Gao, P.J. Smith, and M.V. Clark, Theoretical reliability of MMSE linear diversity combining in Rayleigh-fading additive interference channels, IEEE Transactions on Communications 46 (1998), no. 5, K. I. Gross and D. St. P. Richards, Total positivity, spherical series, and hypergeometric functions of matri argument, J. Appro. Theory 59 (1989), no., MR1118 (91i:335) 1. R. Gutiérrez, J. Rodriguez, and A. J. Sáez, Approimation of hypergeometric functions with matricial argument through their development in series of zonal polynomials, Electron. Trans. Numer. Anal. 11 (), MR17997 (b:334) 11. G. H. Hardy, Ramanujan: Twelve lectures on subjects suggested by his life and work, AMS Chelsea, New York, MR486 (3:71d) 1. M. Kang and M.-S. Alouini, Largest eigenvalue of comple Wishart matrices and performance analysis of MIMO MRC systems, IEEE Journal on Selected Areas in Communications 1 (3), no. 3, P. Koev, I. G. Macdonald, Symmetric functions and Hall polynomials, Second ed., Oford University Press, New York, MR (96h:57) 15. The MathWorks, Inc., Natick, MA, MATLAB reference guide, R.J.Muirhead,Latent roots and matri variates: a review of some asymptotic results, Ann. Statist. 6 (1978), no. 1, MR (56:16919) 17., Aspects of multivariate statistical theory, John Wiley & Sons Inc., New York, 198. MR6593 (84c:673) 18. K. E. Muller, Computing the confluent hypergeometric function, M(a, b, ), Numer. Math. 9 (1), no. 1, MR (3a:3344) 19. A. J. Sáez, Software for calculus of zonal polynomials, R. Stanley, Some combinatorial properties of Jack symmetric functions, Adv. Math. 77 (1989), no. 1, MR11473 (9g:5) 1., Enumerative combinatorics. Vol. 1, Cambridge Studies in Advanced Mathematics, vol. 49, Cambridge University Press, Cambridge, MR1446 (98a:51)., Enumerative combinatorics. Vol., Cambridge Studies in Advanced Mathematics, vol. 6, Cambridge University Press, Cambridge, MR16768 (k:56) Department of Mathematics, Massachusetts Institute of Technology, Cambridge, Massachusetts 139 address: plamen@math.mit.edu Department of Mathematics, Massachusetts Institute of Technology, Cambridge, Massachusetts 139 address: edelman@math.mit.edu

c 2005 Society for Industrial and Applied Mathematics

c 2005 Society for Industrial and Applied Mathematics SIAM J. MATRIX ANAL. APPL. Vol. XX, No. X, pp. XX XX c 005 Society for Industrial and Applied Mathematics DISTRIBUTIONS OF THE EXTREME EIGENVALUES OF THE COMPLEX JACOBI RANDOM MATRIX ENSEMBLE PLAMEN KOEV

More information

On Computing Schur Functions and Series Thereof

On Computing Schur Functions and Series Thereof J Algebr Comb manuscript No. (will be inserted by the editor) On Computing Schur Functions and Series Thereof Cy Chan Vesselin Drensky Alan Edelman Raymond Kan Plamen Koev Received: date / Accepted: date

More information

Progress in the method of Ghosts and Shadows for Beta Ensembles

Progress in the method of Ghosts and Shadows for Beta Ensembles Progress in the method of Ghosts and Shadows for Beta Ensembles Alan Edelman (MIT) Alex Dubbs (MIT) and Plamen Koev (SJS) Oct 8, 2012 1/47 Wishart Matrices (arbitrary covariance) G=mxn matrix of Gaussians

More information

Log-Convexity Properties of Schur Functions and Generalized Hypergeometric Functions of Matrix Argument. Donald St. P. Richards.

Log-Convexity Properties of Schur Functions and Generalized Hypergeometric Functions of Matrix Argument. Donald St. P. Richards. Log-Convexity Properties of Schur Functions and Generalized Hypergeometric Functions of Matrix Argument Donald St. P. Richards August 22, 2009 Abstract We establish a positivity property for the difference

More information

MIT Term Project: Numerical Experiments on Circular Ensembles and Jack Polynomials with Julia

MIT Term Project: Numerical Experiments on Circular Ensembles and Jack Polynomials with Julia MIT 18.338 Term Project: Numerical Experiments on Circular Ensembles and Jack Polynomials with Julia N. Kemal Ure May 15, 2013 Abstract This project studies the numerical experiments related to averages

More information

A Formula for the Specialization of Skew Schur Functions

A Formula for the Specialization of Skew Schur Functions A Formula for the Specialization of Skew Schur Functions The MIT Faculty has made this article openly available. Please share how this access benefits you. Your story matters. Citation As Published Publisher

More information

Chapter 6. Nonlinear Equations. 6.1 The Problem of Nonlinear Root-finding. 6.2 Rate of Convergence

Chapter 6. Nonlinear Equations. 6.1 The Problem of Nonlinear Root-finding. 6.2 Rate of Convergence Chapter 6 Nonlinear Equations 6. The Problem of Nonlinear Root-finding In this module we consider the problem of using numerical techniques to find the roots of nonlinear equations, f () =. Initially we

More information

arxiv:math/ v5 [math.ac] 17 Sep 2009

arxiv:math/ v5 [math.ac] 17 Sep 2009 On the elementary symmetric functions of a sum of matrices R. S. Costas-Santos arxiv:math/0612464v5 [math.ac] 17 Sep 2009 September 17, 2009 Abstract Often in mathematics it is useful to summarize a multivariate

More information

Advances in Random Matrix Theory: Let there be tools

Advances in Random Matrix Theory: Let there be tools Advances in Random Matrix Theory: Let there be tools Alan Edelman Brian Sutton, Plamen Koev, Ioana Dumitriu, Raj Rao and others MIT: Dept of Mathematics, Computer Science AI Laboratories World Congress,

More information

Linear Equations in Linear Algebra

Linear Equations in Linear Algebra 1 Linear Equations in Linear Algebra 1.1 SYSTEMS OF LINEAR EQUATIONS LINEAR EQUATION,, 1 n A linear equation in the variables equation that can be written in the form a a a b 1 1 2 2 n n a a is an where

More information

On the Multivariate Nakagami-m Distribution With Exponential Correlation

On the Multivariate Nakagami-m Distribution With Exponential Correlation 1240 IEEE TRANSACTIONS ON COMMUNICATIONS, VOL. 51, NO. 8, AUGUST 2003 On the Multivariate Nakagami-m Distribution With Exponential Correlation George K. Karagiannidis, Member, IEEE, Dimitris A. Zogas,

More information

CSCI-6971 Lecture Notes: Probability theory

CSCI-6971 Lecture Notes: Probability theory CSCI-6971 Lecture Notes: Probability theory Kristopher R. Beevers Department of Computer Science Rensselaer Polytechnic Institute beevek@cs.rpi.edu January 31, 2006 1 Properties of probabilities Let, A,

More information

Research Article On the Marginal Distribution of the Diagonal Blocks in a Blocked Wishart Random Matrix

Research Article On the Marginal Distribution of the Diagonal Blocks in a Blocked Wishart Random Matrix Hindawi Publishing Corporation nternational Journal of Analysis Volume 6, Article D 59678, 5 pages http://dx.doi.org/.55/6/59678 Research Article On the Marginal Distribution of the Diagonal Blocks in

More information

Example 1: What do you know about the graph of the function

Example 1: What do you know about the graph of the function Section 1.5 Analyzing of Functions In this section, we ll look briefly at four types of functions: polynomial functions, rational functions, eponential functions and logarithmic functions. Eample 1: What

More information

An Efficient Approach to Multivariate Nakagami-m Distribution Using Green s Matrix Approximation

An Efficient Approach to Multivariate Nakagami-m Distribution Using Green s Matrix Approximation IEEE TRANSACTIONS ON WIRELESS COMMUNICATIONS, VOL 2, NO 5, SEPTEMBER 2003 883 An Efficient Approach to Multivariate Nakagami-m Distribution Using Green s Matrix Approximation George K Karagiannidis, Member,

More information

ACCURATE AND EFFICIENT EVALUATION OF SCHUR AND JACK FUNCTIONS

ACCURATE AND EFFICIENT EVALUATION OF SCHUR AND JACK FUNCTIONS MATHEMATICS OF COMPUTATION Volume 75, Number 253, Pages 223 239 S 0025-5718(05)01780-1 Article electronically published on August 31, 2005 ACCURATE AND EFFICIENT EVALUATION OF SCHUR AND JACK FUNCTIONS

More information

MINIMAL NORMAL AND COMMUTING COMPLETIONS

MINIMAL NORMAL AND COMMUTING COMPLETIONS INTERNATIONAL JOURNAL OF INFORMATION AND SYSTEMS SCIENCES Volume 4, Number 1, Pages 5 59 c 8 Institute for Scientific Computing and Information MINIMAL NORMAL AND COMMUTING COMPLETIONS DAVID P KIMSEY AND

More information

INF4130: Dynamic Programming September 2, 2014 DRAFT version

INF4130: Dynamic Programming September 2, 2014 DRAFT version INF4130: Dynamic Programming September 2, 2014 DRAFT version In the textbook: Ch. 9, and Section 20.5 Chapter 9 can also be found at the home page for INF4130 These slides were originally made by Petter

More information

Unifying Analysis of Ergodic MIMO Capacity in Correlated Rayleigh Fading Environments

Unifying Analysis of Ergodic MIMO Capacity in Correlated Rayleigh Fading Environments Unifying Analysis of Ergodic MIMO Capacity in Correlated Rayleigh Fading Environments Mario Kiessling,, Joachim Speidel, Markus Reinhar Institute of elecommunications, University of Stuttgart, Germany

More information

Extension of Summation Formulas involving Stirling series

Extension of Summation Formulas involving Stirling series Etension of Summation Formulas involving Stirling series Raphael Schumacher arxiv:6050904v [mathnt] 6 May 06 Abstract This paper presents a family of rapidly convergent summation formulas for various finite

More information

Rectangular Young tableaux and the Jacobi ensemble

Rectangular Young tableaux and the Jacobi ensemble Rectangular Young tableaux and the Jacobi ensemble Philippe Marchal October 20, 2015 Abstract It has been shown by Pittel and Romik that the random surface associated with a large rectangular Young tableau

More information

1. Introduction. Let an n m complex Gaussian random matrix A be distributed

1. Introduction. Let an n m complex Gaussian random matrix A be distributed COMMUNICATIONS IN INFORMATION AND SYSTEMS c 23 International Press Vol 3, No 2, pp 119-138, October 23 3 COMPLEX RANDOM MATRICES AND RAYLEIGH CHANNEL CAPACITY T RATNARAJAH, R VAILLANCOURT, AND M ALVO Abstract

More information

Generalized Near-Bell Numbers

Generalized Near-Bell Numbers 1 2 3 47 6 23 11 Journal of Integer Sequences, Vol. 12 2009, Article 09.5.7 Generalized Near-Bell Numbers Martin Griffiths Department of Mathematical Sciences University of Esse Wivenhoe Par Colchester

More information

Exact and Approximate Numbers:

Exact and Approximate Numbers: Eact and Approimate Numbers: The numbers that arise in technical applications are better described as eact numbers because there is not the sort of uncertainty in their values that was described above.

More information

The incomplete gamma functions. Notes by G.J.O. Jameson. These notes incorporate the Math. Gazette article [Jam1], with some extra material.

The incomplete gamma functions. Notes by G.J.O. Jameson. These notes incorporate the Math. Gazette article [Jam1], with some extra material. The incomplete gamma functions Notes by G.J.O. Jameson These notes incorporate the Math. Gazette article [Jam], with some etra material. Definitions and elementary properties functions: Recall the integral

More information

Two finite forms of Watson s quintuple product identity and matrix inversion

Two finite forms of Watson s quintuple product identity and matrix inversion Two finite forms of Watson s uintuple product identity and matrix inversion X. Ma Department of Mathematics SuZhou University, SuZhou 215006, P.R.China Submitted: Jan 24, 2006; Accepted: May 27, 2006;

More information

0.1. Linear transformations

0.1. Linear transformations Suggestions for midterm review #3 The repetitoria are usually not complete; I am merely bringing up the points that many people didn t now on the recitations Linear transformations The following mostly

More information

Computing Consecutive-Type Reliabilities Non-Recursively

Computing Consecutive-Type Reliabilities Non-Recursively IEEE TRANSACTIONS ON RELIABILITY, VOL. 52, NO. 3, SEPTEMBER 2003 367 Computing Consecutive-Type Reliabilities Non-Recursively Galit Shmueli Abstract The reliability of consecutive-type systems has been

More information

k-protected VERTICES IN BINARY SEARCH TREES

k-protected VERTICES IN BINARY SEARCH TREES k-protected VERTICES IN BINARY SEARCH TREES MIKLÓS BÓNA Abstract. We show that for every k, the probability that a randomly selected vertex of a random binary search tree on n nodes is at distance k from

More information

672 IEEE TRANSACTIONS ON SIGNAL PROCESSING, VOL. 57, NO. 2, FEBRUARY We only include here some relevant references that focus on the complex

672 IEEE TRANSACTIONS ON SIGNAL PROCESSING, VOL. 57, NO. 2, FEBRUARY We only include here some relevant references that focus on the complex 672 IEEE TRANSACTIONS ON SIGNAL PROCESSING, VOL. 57, NO. 2, FEBRUARY 2009 Ordered Eigenvalues of a General Class of Hermitian Rom Matrices With Application to the Performance Analysis of MIMO Systems Luis

More information

A Generating Algorithm for Ribbon Tableaux and Spin Polynomials

A Generating Algorithm for Ribbon Tableaux and Spin Polynomials Discrete Mathematics and Theoretical Computer Science DMTCS vol. 9:, 007, 5 58 A Generating Algorithm for Ribbon Tableaux and Spin Polynomials Francois Descouens Institut Gaspard Monge, Université de Marne-la-Vallée

More information

MATH39001 Generating functions. 1 Ordinary power series generating functions

MATH39001 Generating functions. 1 Ordinary power series generating functions MATH3900 Generating functions The reference for this part of the course is generatingfunctionology by Herbert Wilf. The 2nd edition is downloadable free from http://www.math.upenn. edu/~wilf/downldgf.html,

More information

Descents in Parking Functions

Descents in Parking Functions 1 2 3 47 6 23 11 Journal of Integer Sequences, Vol. 21 (2018), Article 18.2.3 Descents in Parking Functions Paul R. F. Schumacher 1512 Oakview Street Bryan, TX 77802 USA Paul.R.F.Schumacher@gmail.com Abstract

More information

Application of modified Leja sequences to polynomial interpolation

Application of modified Leja sequences to polynomial interpolation Special Issue for the years of the Padua points, Volume 8 5 Pages 66 74 Application of modified Leja sequences to polynomial interpolation L. P. Bos a M. Caliari a Abstract We discuss several applications

More information

Taylor Series and Asymptotic Expansions

Taylor Series and Asymptotic Expansions Taylor Series and Asymptotic Epansions The importance of power series as a convenient representation, as an approimation tool, as a tool for solving differential equations and so on, is pretty obvious.

More information

Solve Wave Equation from Scratch [2013 HSSP]

Solve Wave Equation from Scratch [2013 HSSP] 1 Solve Wave Equation from Scratch [2013 HSSP] Yuqi Zhu MIT Department of Physics, 77 Massachusetts Ave., Cambridge, MA 02139 (Dated: August 18, 2013) I. COURSE INFO Topics Date 07/07 Comple number, Cauchy-Riemann

More information

THE LECTURE HALL PARALLELEPIPED

THE LECTURE HALL PARALLELEPIPED THE LECTURE HALL PARALLELEPIPED FU LIU AND RICHARD P. STANLEY Abstract. The s-lecture hall polytopes P s are a class of integer polytopes defined by Savage and Schuster which are closely related to the

More information

MATH 1010E University Mathematics Lecture Notes (week 8) Martin Li

MATH 1010E University Mathematics Lecture Notes (week 8) Martin Li MATH 1010E University Mathematics Lecture Notes (week 8) Martin Li 1 L Hospital s Rule Another useful application of mean value theorems is L Hospital s Rule. It helps us to evaluate its of indeterminate

More information

Holonomic Gradient Method for Multivariate Normal Distribution Theory. Akimichi Takemura, Univ. of Tokyo August 2, 2013

Holonomic Gradient Method for Multivariate Normal Distribution Theory. Akimichi Takemura, Univ. of Tokyo August 2, 2013 Holonomic Gradient Method for Multivariate Normal Distribution Theory Akimichi Takemura, Univ. of Tokyo August 2, 2013 Items 1. First example (non-central t-distribution, by T.Sei) 2. Principles of HGM

More information

Journal of Multivariate Analysis. Sphericity test in a GMANOVA MANOVA model with normal error

Journal of Multivariate Analysis. Sphericity test in a GMANOVA MANOVA model with normal error Journal of Multivariate Analysis 00 (009) 305 3 Contents lists available at ScienceDirect Journal of Multivariate Analysis journal homepage: www.elsevier.com/locate/jmva Sphericity test in a GMANOVA MANOVA

More information

More calculations on determinant evaluations

More calculations on determinant evaluations Electronic Journal of Linear Algebra Volume 16 Article 007 More calculations on determinant evaluations A. R. Moghaddamfar moghadam@kntu.ac.ir S. M. H. Pooya S. Navid Salehy S. Nima Salehy Follow this

More information

Spectral inequalities and equalities involving products of matrices

Spectral inequalities and equalities involving products of matrices Spectral inequalities and equalities involving products of matrices Chi-Kwong Li 1 Department of Mathematics, College of William & Mary, Williamsburg, Virginia 23187 (ckli@math.wm.edu) Yiu-Tung Poon Department

More information

Two Remarks on Skew Tableaux

Two Remarks on Skew Tableaux Two Remarks on Skew Tableaux Richard P. Stanley Department of Mathematics Massachusetts Institute of Technology Cambridge, MA 02139 rstan@math.mit.edu Submitted: 2011; Accepted: 2011; Published: XX Mathematics

More information

A Combinatorial Interpretation of the Numbers 6 (2n)! /n! (n + 2)!

A Combinatorial Interpretation of the Numbers 6 (2n)! /n! (n + 2)! 1 2 3 47 6 23 11 Journal of Integer Sequences, Vol. 8 (2005), Article 05.2.3 A Combinatorial Interpretation of the Numbers 6 (2n)! /n! (n + 2)! Ira M. Gessel 1 and Guoce Xin Department of Mathematics Brandeis

More information

MOPS: Multivariate orthogonal polynomials (symbolically)

MOPS: Multivariate orthogonal polynomials (symbolically) Journal of Symbolic Computation 42 2007) 587 620 www.elsevier.com/locate/jsc MOPS: Multivariate orthogonal polynomials symbolically) Ioana Dumitriu a,, Alan Edelman b, Gene Shuman c a Department of Mathematics,

More information

MAXIMAL PERIODS OF (EHRHART) QUASI-POLYNOMIALS

MAXIMAL PERIODS OF (EHRHART) QUASI-POLYNOMIALS MAXIMAL PERIODS OF (EHRHART QUASI-POLYNOMIALS MATTHIAS BECK, STEVEN V. SAM, AND KEVIN M. WOODS Abstract. A quasi-polynomial is a function defined of the form q(k = c d (k k d + c d 1 (k k d 1 + + c 0(k,

More information

Multivariate Distributions

Multivariate Distributions IEOR E4602: Quantitative Risk Management Spring 2016 c 2016 by Martin Haugh Multivariate Distributions We will study multivariate distributions in these notes, focusing 1 in particular on multivariate

More information

Near-exact approximations for the likelihood ratio test statistic for testing equality of several variance-covariance matrices

Near-exact approximations for the likelihood ratio test statistic for testing equality of several variance-covariance matrices Near-exact approximations for the likelihood ratio test statistic for testing euality of several variance-covariance matrices Carlos A. Coelho 1 Filipe J. Marues 1 Mathematics Department, Faculty of Sciences

More information

SYLLABUS FOR ENTRANCE EXAMINATION NANYANG TECHNOLOGICAL UNIVERSITY FOR INTERNATIONAL STUDENTS A-LEVEL MATHEMATICS

SYLLABUS FOR ENTRANCE EXAMINATION NANYANG TECHNOLOGICAL UNIVERSITY FOR INTERNATIONAL STUDENTS A-LEVEL MATHEMATICS SYLLABUS FOR ENTRANCE EXAMINATION NANYANG TECHNOLOGICAL UNIVERSITY FOR INTERNATIONAL STUDENTS A-LEVEL MATHEMATICS STRUCTURE OF EXAMINATION PAPER. There will be one -hour paper consisting of 4 questions..

More information

Free Probability, Sample Covariance Matrices and Stochastic Eigen-Inference

Free Probability, Sample Covariance Matrices and Stochastic Eigen-Inference Free Probability, Sample Covariance Matrices and Stochastic Eigen-Inference Alan Edelman Department of Mathematics, Computer Science and AI Laboratories. E-mail: edelman@math.mit.edu N. Raj Rao Deparment

More information

Representation of Lie Groups and Special Functions

Representation of Lie Groups and Special Functions Representation of Lie Groups and Special Functions Recent Advances by N. Ja. Vilenkint formerly of The Correspondence Pedagogical Institute, Moscow, Russia and A.U. Klimyk Institute for Theoretical Physics,

More information

Euler-Maclaurin summation formula

Euler-Maclaurin summation formula Physics 4 Spring 6 Euler-Maclaurin summation formula Lecture notes by M. G. Rozman Last modified: March 9, 6 Euler-Maclaurin summation formula gives an estimation of the sum N in f i) in terms of the integral

More information

The generalized order-k Fibonacci Pell sequence by matrix methods

The generalized order-k Fibonacci Pell sequence by matrix methods Journal of Computational and Applied Mathematics 09 (007) 33 45 wwwelseviercom/locate/cam The generalized order- Fibonacci Pell sequence by matrix methods Emrah Kilic Mathematics Department, TOBB University

More information

Meixner matrix ensembles

Meixner matrix ensembles Meixner matrix ensembles W lodek Bryc 1 Cincinnati April 12, 2011 1 Based on joint work with Gerard Letac W lodek Bryc (Cincinnati) Meixner matrix ensembles April 12, 2011 1 / 29 Outline of talk Random

More information

Calculation of Cylindrical Functions using Correction of Asymptotic Expansions

Calculation of Cylindrical Functions using Correction of Asymptotic Expansions Universal Journal of Applied Mathematics & Computation (4), 5-46 www.papersciences.com Calculation of Cylindrical Functions using Correction of Asymptotic Epansions G.B. Muravskii Faculty of Civil and

More information

1 Rational Exponents and Radicals

1 Rational Exponents and Radicals Introductory Algebra Page 1 of 11 1 Rational Eponents and Radicals 1.1 Rules of Eponents The rules for eponents are the same as what you saw earlier. Memorize these rules if you haven t already done so.

More information

A Padé approximation to the scalar wavefield extrapolator for inhomogeneous media

A Padé approximation to the scalar wavefield extrapolator for inhomogeneous media A Padé approimation A Padé approimation to the scalar wavefield etrapolator for inhomogeneous media Yanpeng Mi, Zhengsheng Yao, and Gary F. Margrave ABSTRACT A seismic wavefield at depth z can be obtained

More information

OPTIMAL SCALING FOR P -NORMS AND COMPONENTWISE DISTANCE TO SINGULARITY

OPTIMAL SCALING FOR P -NORMS AND COMPONENTWISE DISTANCE TO SINGULARITY published in IMA Journal of Numerical Analysis (IMAJNA), Vol. 23, 1-9, 23. OPTIMAL SCALING FOR P -NORMS AND COMPONENTWISE DISTANCE TO SINGULARITY SIEGFRIED M. RUMP Abstract. In this note we give lower

More information

Algebraic Algorithm for 2D Stability Test Based on a Lyapunov Equation. Abstract

Algebraic Algorithm for 2D Stability Test Based on a Lyapunov Equation. Abstract Algebraic Algorithm for 2D Stability Test Based on a Lyapunov Equation Minoru Yamada Li Xu Osami Saito Abstract Some improvements have been proposed for the algorithm of Agathoklis such that 2D stability

More information

MIMO Capacities : Eigenvalue Computation through Representation Theory

MIMO Capacities : Eigenvalue Computation through Representation Theory MIMO Capacities : Eigenvalue Computation through Representation Theory Jayanta Kumar Pal, Donald Richards SAMSI Multivariate distributions working group Outline 1 Introduction 2 MIMO working model 3 Eigenvalue

More information

Holonomic gradient method for hypergeometric functions of a matrix argument Akimichi Takemura, Shiga University

Holonomic gradient method for hypergeometric functions of a matrix argument Akimichi Takemura, Shiga University Holonomic gradient method for hypergeometric functions of a matrix argument Akimichi Takemura, Shiga University (joint with H.Hashiguchi and N.Takayama) June 20, 2016, RIMS, Kyoto Items 1. Summary of multivariate

More information

THE SMITH NORMAL FORM OF A SPECIALIZED JACOBI-TRUDI MATRIX

THE SMITH NORMAL FORM OF A SPECIALIZED JACOBI-TRUDI MATRIX THE SMITH NORMAL FORM OF A SPECIALIZED JACOBI-TRUDI MATRIX RICHARD P. STANLEY Abstract. LetJT λ bethejacobi-trudimatrixcorrespondingtothepartitionλ, sodetjt λ is the Schur function s λ in the variables

More information

Partitions, rooks, and symmetric functions in noncommuting variables

Partitions, rooks, and symmetric functions in noncommuting variables Partitions, rooks, and symmetric functions in noncommuting variables Mahir Bilen Can Department of Mathematics, Tulane University New Orleans, LA 70118, USA, mcan@tulane.edu and Bruce E. Sagan Department

More information

Math Subject GRE Questions

Math Subject GRE Questions Math Subject GRE Questions Calculus and Differential Equations 1. If f() = e e, then [f ()] 2 [f()] 2 equals (a) 4 (b) 4e 2 (c) 2e (d) 2 (e) 2e 2. An integrating factor for the ordinary differential equation

More information

Iyad T. Abu-Jeib and Thomas S. Shores

Iyad T. Abu-Jeib and Thomas S. Shores NEW ZEALAND JOURNAL OF MATHEMATICS Volume 3 (003, 9 ON PROPERTIES OF MATRIX I ( OF SINC METHODS Iyad T. Abu-Jeib and Thomas S. Shores (Received February 00 Abstract. In this paper, we study the determinant

More information

Pre-Calculus and Trigonometry Capacity Matrix

Pre-Calculus and Trigonometry Capacity Matrix Pre-Calculus and Capacity Matri Review Polynomials A1.1.4 A1.2.5 Add, subtract, multiply and simplify polynomials and rational epressions Solve polynomial equations and equations involving rational epressions

More information

Two Remarks on Skew Tableaux

Two Remarks on Skew Tableaux Two Remarks on Skew Tableaux The MIT Faculty has made this article openly available. Please share how this access benefits you. Your story matters. Citation As Published Publisher Stanley, Richard P. "Two

More information

The Random Matrix Technique of Ghosts and Shadows

The Random Matrix Technique of Ghosts and Shadows The Random Matrix Technique of Ghosts and Shadows Alan Edelman November 22, 2009 Abstract We propose to abandon the notion that a random matrix has to be sampled for it to exist. Much of today's applied

More information

WBHS Algebra 2 - Final Exam

WBHS Algebra 2 - Final Exam Class: _ Date: _ WBHS Algebra 2 - Final Eam Multiple Choice Identify the choice that best completes the statement or answers the question. Describe the pattern in the sequence. Find the net three terms.

More information

Lecture 4.2 Finite Difference Approximation

Lecture 4.2 Finite Difference Approximation Lecture 4. Finite Difference Approimation 1 Discretization As stated in Lecture 1.0, there are three steps in numerically solving the differential equations. They are: 1. Discretization of the domain by

More information

Plotting data is one method for selecting a probability distribution. The following

Plotting data is one method for selecting a probability distribution. The following Advanced Analytical Models: Over 800 Models and 300 Applications from the Basel II Accord to Wall Street and Beyond By Johnathan Mun Copyright 008 by Johnathan Mun APPENDIX C Understanding and Choosing

More information

ON ORTHOGONAL REDUCTION TO HESSENBERG FORM WITH SMALL BANDWIDTH

ON ORTHOGONAL REDUCTION TO HESSENBERG FORM WITH SMALL BANDWIDTH ON ORTHOGONAL REDUCTION TO HESSENBERG FORM WITH SMALL BANDWIDTH V. FABER, J. LIESEN, AND P. TICHÝ Abstract. Numerous algorithms in numerical linear algebra are based on the reduction of a given matrix

More information

Unbounded Regions of Infinitely Logconcave Sequences

Unbounded Regions of Infinitely Logconcave Sequences The University of San Francisco USF Scholarship: a digital repository @ Gleeson Library Geschke Center Mathematics College of Arts and Sciences 007 Unbounded Regions of Infinitely Logconcave Sequences

More information

Random Matrix Theory Lecture 1 Introduction, Ensembles and Basic Laws. Symeon Chatzinotas February 11, 2013 Luxembourg

Random Matrix Theory Lecture 1 Introduction, Ensembles and Basic Laws. Symeon Chatzinotas February 11, 2013 Luxembourg Random Matrix Theory Lecture 1 Introduction, Ensembles and Basic Laws Symeon Chatzinotas February 11, 2013 Luxembourg Outline 1. Random Matrix Theory 1. Definition 2. Applications 3. Asymptotics 2. Ensembles

More information

MATRIX REPRESENTATIONS FOR MULTIPLICATIVE NESTED SUMS. 1. Introduction. The harmonic sums, defined by [BK99, eq. 4, p. 1] sign (i 1 ) n 1 (N) :=

MATRIX REPRESENTATIONS FOR MULTIPLICATIVE NESTED SUMS. 1. Introduction. The harmonic sums, defined by [BK99, eq. 4, p. 1] sign (i 1 ) n 1 (N) := MATRIX REPRESENTATIONS FOR MULTIPLICATIVE NESTED SUMS LIN JIU AND DIANE YAHUI SHI* Abstract We study the multiplicative nested sums which are generalizations of the harmonic sums and provide a calculation

More information

a+bi form abscissa absolute value x x x absolute value equation x x absolute value function absolute value inequality x x accurate adjacent angles

a+bi form abscissa absolute value x x x absolute value equation x x absolute value function absolute value inequality x x accurate adjacent angles Words CR PS Reason Comm Geom ALG Stat Prob NSO a+bi form abscissa absolute value absolute value equation absolute value function absolute value inequality accurate adjacent angles adjacent sides algebraic

More information

Computer Problems for Taylor Series and Series Convergence

Computer Problems for Taylor Series and Series Convergence Computer Problems for Taylor Series and Series Convergence The two problems below are a set; the first should be done without a computer and the second is a computer-based follow up. 1. The drawing below

More information

#A29 INTEGERS 11 (2011) THE (EXPONENTIAL) BIPARTITIONAL POLYNOMIALS AND POLYNOMIAL SEQUENCES OF TRINOMIAL TYPE: PART II

#A29 INTEGERS 11 (2011) THE (EXPONENTIAL) BIPARTITIONAL POLYNOMIALS AND POLYNOMIAL SEQUENCES OF TRINOMIAL TYPE: PART II #A29 INTEGERS 11 (2011) THE (EXPONENTIAL) BIPARTITIONAL POLYNOMIALS AND POLYNOMIAL SEQUENCES OF TRINOMIAL TYPE: PART II Hacène Belbachir 1 USTHB, Faculty of Mathematics, El Alia, Bab Ezzouar, Algeria hbelbachir@usthb.dz

More information

Two-boundary lattice paths and parking functions

Two-boundary lattice paths and parking functions Two-boundary lattice paths and parking functions Joseph PS Kung 1, Xinyu Sun 2, and Catherine Yan 3,4 1 Department of Mathematics, University of North Texas, Denton, TX 76203 2,3 Department of Mathematics

More information

A Characterization of (3+1)-Free Posets

A Characterization of (3+1)-Free Posets Journal of Combinatorial Theory, Series A 93, 231241 (2001) doi:10.1006jcta.2000.3075, available online at http:www.idealibrary.com on A Characterization of (3+1)-Free Posets Mark Skandera Department of

More information

Fast reversion of formal power series

Fast reversion of formal power series Fast reversion of formal power series Fredrik Johansson LFANT, INRIA Bordeaux RAIM, 2016-06-29, Banyuls-sur-mer 1 / 30 Reversion of power series F = exp(x) 1 = x + x 2 2! + x 3 3! + x 4 G = log(1 + x)

More information

Approximate formulas for the Point-to-Ellipse and for the Point-to-Ellipsoid Distance Problem

Approximate formulas for the Point-to-Ellipse and for the Point-to-Ellipsoid Distance Problem Approimate formulas for the Point-to-Ellipse and for the Point-to-Ellipsoid Distance Problem ALEXEI UTESHEV St.Petersburg State University Department of Applied Mathematics Universitetskij pr. 35, 198504

More information

Generalized Akiyama-Tanigawa Algorithm for Hypersums of Powers of Integers

Generalized Akiyama-Tanigawa Algorithm for Hypersums of Powers of Integers 1 2 3 47 6 23 11 Journal of Integer Sequences, Vol 16 (2013, Article 1332 Generalized Aiyama-Tanigawa Algorithm for Hypersums of Powers of Integers José Luis Cereceda Distrito Telefónica, Edificio Este

More information

1. Introduction The incomplete beta function I(a, b, x) is defined by [1, p.269, Eq and p.944, Eq ]

1. Introduction The incomplete beta function I(a, b, x) is defined by [1, p.269, Eq and p.944, Eq ] MATHEMATICS OF COMPUTATION Volume 65, Number 215 July 1996, Pages 1283 1288 AN ASYMPTOTIC EXPANSION FOR THE INCOMPLETE BETA FUNCTION B.G.S. DOMAN Abstract. A new asymptotic expansion is derived for the

More information

Computing the pth Roots of a Matrix. with Repeated Eigenvalues

Computing the pth Roots of a Matrix. with Repeated Eigenvalues Applied Mathematical Sciences, Vol. 5, 2011, no. 53, 2645-2661 Computing the pth Roots of a Matrix with Repeated Eigenvalues Amir Sadeghi 1, Ahmad Izani Md. Ismail and Azhana Ahmad School of Mathematical

More information

Asymptotics of Integrals of. Hermite Polynomials

Asymptotics of Integrals of. Hermite Polynomials Applied Mathematical Sciences, Vol. 4, 010, no. 61, 04-056 Asymptotics of Integrals of Hermite Polynomials R. B. Paris Division of Complex Systems University of Abertay Dundee Dundee DD1 1HG, UK R.Paris@abertay.ac.uk

More information

= 1 2 x (x 1) + 1 {x} (1 {x}). [t] dt = 1 x (x 1) + O (1), [t] dt = 1 2 x2 + O (x), (where the error is not now zero when x is an integer.

= 1 2 x (x 1) + 1 {x} (1 {x}). [t] dt = 1 x (x 1) + O (1), [t] dt = 1 2 x2 + O (x), (where the error is not now zero when x is an integer. Problem Sheet,. i) Draw the graphs for [] and {}. ii) Show that for α R, α+ α [t] dt = α and α+ α {t} dt =. Hint Split these integrals at the integer which must lie in any interval of length, such as [α,

More information

Random Matrices and Multivariate Statistical Analysis

Random Matrices and Multivariate Statistical Analysis Random Matrices and Multivariate Statistical Analysis Iain Johnstone, Statistics, Stanford imj@stanford.edu SEA 06@MIT p.1 Agenda Classical multivariate techniques Principal Component Analysis Canonical

More information

The Perrin Conjugate and the Laguerre Orthogonal Polynomial

The Perrin Conjugate and the Laguerre Orthogonal Polynomial The Perrin Conjugate and the Laguerre Orthogonal Polynomial In a previous chapter I defined the conjugate of a cubic polynomial G(x) = x 3 - Bx Cx - D as G(x)c = x 3 + Bx Cx + D. By multiplying the polynomial

More information

Limits for BC Jacobi polynomials

Limits for BC Jacobi polynomials Limits for Korteweg-de Vries Institute, University of Amsterdam T.H.Koornwinder@uva.nl http://www.science.uva.nl/~thk/ Lecture on September 10, 2012 at the Conference on Harmonic Analysis, Convolution

More information

INTRODUCTION TO MARKOV CHAINS AND MARKOV CHAIN MIXING

INTRODUCTION TO MARKOV CHAINS AND MARKOV CHAIN MIXING INTRODUCTION TO MARKOV CHAINS AND MARKOV CHAIN MIXING ERIC SHANG Abstract. This paper provides an introduction to Markov chains and their basic classifications and interesting properties. After establishing

More information

SEA s workshop- MIT - July 10-14

SEA s workshop- MIT - July 10-14 Matrix-valued Stochastic Processes- Eigenvalues Processes and Free Probability SEA s workshop- MIT - July 10-14 July 13, 2006 Outline Matrix-valued stochastic processes. 1- definition and examples. 2-

More information

MA10103: Foundation Mathematics I. Lecture Notes Week 1

MA10103: Foundation Mathematics I. Lecture Notes Week 1 MA00: Foundation Mathematics I Lecture Notes Week Numbers The naturals are the nonnegative whole numbers, i.e., 0,,,, 4,.... The set of naturals is denoted by N. Warning: Sometimes only the positive integers

More information

18.S34 linear algebra problems (2007)

18.S34 linear algebra problems (2007) 18.S34 linear algebra problems (2007) Useful ideas for evaluating determinants 1. Row reduction, expanding by minors, or combinations thereof; sometimes these are useful in combination with an induction

More information

Numerical Integration (Quadrature) Another application for our interpolation tools!

Numerical Integration (Quadrature) Another application for our interpolation tools! Numerical Integration (Quadrature) Another application for our interpolation tools! Integration: Area under a curve Curve = data or function Integrating data Finite number of data points spacing specified

More information

The restarted QR-algorithm for eigenvalue computation of structured matrices

The restarted QR-algorithm for eigenvalue computation of structured matrices Journal of Computational and Applied Mathematics 149 (2002) 415 422 www.elsevier.com/locate/cam The restarted QR-algorithm for eigenvalue computation of structured matrices Daniela Calvetti a; 1, Sun-Mi

More information

COUNCIL ROCK HIGH SCHOOL MATHEMATICS. A Note Guideline of Algebraic Concepts. Designed to assist students in A Summer Review of Algebra

COUNCIL ROCK HIGH SCHOOL MATHEMATICS. A Note Guideline of Algebraic Concepts. Designed to assist students in A Summer Review of Algebra COUNCIL ROCK HIGH SCHOOL MATHEMATICS A Note Guideline of Algebraic Concepts Designed to assist students in A Summer Review of Algebra [A teacher prepared compilation of the 7 Algebraic concepts deemed

More information

ACCUPLACER MATH 0310

ACCUPLACER MATH 0310 The University of Teas at El Paso Tutoring and Learning Center ACCUPLACER MATH 00 http://www.academics.utep.edu/tlc MATH 00 Page Linear Equations Linear Equations Eercises 5 Linear Equations Answer to

More information

Lecture 9: SVD, Low Rank Approximation

Lecture 9: SVD, Low Rank Approximation CSE 521: Design and Analysis of Algorithms I Spring 2016 Lecture 9: SVD, Low Rank Approimation Lecturer: Shayan Oveis Gharan April 25th Scribe: Koosha Khalvati Disclaimer: hese notes have not been subjected

More information

On Böttcher s mysterious identity

On Böttcher s mysterious identity AUSTRALASIAN JOURNAL OF COBINATORICS Volume 43 (2009), Pages 307 316 On Böttcher s mysterious identity Ömer Eğecioğlu Department of Computer Science University of California Santa Barbara, CA 93106 U.S.A.

More information