[go: up one dir, main page]
More Web Proxy on the site http://driver.im/
login
Search: a001190 -id:a001190
     Sort: relevance | references | number | modified | created      Format: long | short | data
G.f.: 1/(1-G001190), where G001190 = x + x^2 + x^3 + 2x^4 + 3x^5 + ... is the g.f. for the Wedderburn-Etherington numbers A001190.
+20
5
1, 1, 2, 4, 9, 20, 46, 106, 248, 582, 1376, 3264, 7777, 18581, 44526, 106936, 257379, 620577, 1498788, 3625026, 8779271, 21287278, 51671864, 125550018, 305333281, 743179460, 1810290446, 4412783988, 10763786019, 26271534125, 64158771500, 156769178340
OFFSET
0,3
COMMENTS
a(n) is also the number of interpretations of c*x^n (or number of ways to insert parentheses) when multiplication is commutative but not associative. E.g. a(2) = 2: c(x^2) and (c.x)x. a(3)=4: c(x.x^2), (c.x)(x^2), (c.x^2)x, and ((c.x)x)x. - Paul Zimmermann, Dec 04 2009
LINKS
M. R. Bremner, L. A. Peresi and J. Sanchez-Ortega, Malcev dialgebras, arXiv preprint arXiv:1108.0586 [math.RA], 2011.
Chloe E. Shiff and Noah A. Rosenberg, Enumeration of rooted binary perfect phylogenies, arXiv:2410.14915 [q-bio.PE], 2024. See pp. 9, 17.
FORMULA
G.f. A(x) satisfies: x * A(x)^2 = B(x * A(x^2)) where B(x) = x / (1 - 2*x). - Michael Somos, Feb 17 2004
EXAMPLE
G.f. = 1 + x + 2*x^2 + 4*x^3 + 9*x^4 + 20*x^5 + 46*x^6 + 106*x^7 + 248*x^8 + ...
MAPLE
b:= proc(n) option remember; `if`(n<2, n, `if`(n::odd, 0,
(t-> t*(1-t)/2)(b(n/2)))+add(b(i)*b(n-i), i=1..n/2))
end:
a:= proc(n) option remember; `if`(n<1, 1,
add(a(n-i)*b(i), i=1..n))
end:
seq(a(n), n=0..25); # Alois P. Heinz, Sep 07 2017
MATHEMATICA
b[n_] := b[n] = If[n < 2, n, If[OddQ[n], 0, Function[t, t*(1 - t)/2][ b[n/2] ] ] + Sum[b[i]*b[n - i], {i, 1, n/2}] ];
a[n_] := a[n] = If[n < 1, 1, Sum[a[n - i]*b[i], {i, 1, n}]];
Table[a[n], {n, 0, 25}] (* Jean-François Alcover, Nov 06 2017, after Alois P. Heinz *)
PROG
(PARI) {a(n) = local(A, m); if( n<0, 0, A = 1 + O(x); m=1; while( m<=n, m*=2; A = sqrt( subst( x / (1 - 2*x), x, x * subst(A, x, x^2)) / x)); polcoeff(A, n))}; /* Michael Somos, Feb 17 2004 */
CROSSREFS
Cf. A001190.
KEYWORD
nonn
AUTHOR
N. J. A. Sloane, Nov 07 2003
STATUS
approved
A variant of the recurrence for A001190.
+20
2
0, 1, 1, 1, 2, 2, 5, 7, 17, 29, 66, 126, 284, 568, 1281, 2662, 6017, 12756, 28992, 62621, 142801, 312129, 714760, 1578706, 3626762, 8074580, 18606900, 41716797, 96374235, 217271226, 503159109, 1139963936, 2645397326, 6018491701
OFFSET
0,5
MAPLE
A038750 := proc(n) option remember; local s, k; if n<=1 then RETURN(n); elif n <=3 then RETURN(1); else s := 0; if n mod 2 = 0 then s := A038750(n/2)*(A038750(n/2)+1)/2; for k from 1 to n/2-1 do s := s+A038750(k)*A038750(n-k); od; RETURN(s); else for k from 1 to (n-1)/2-1 do s := s+A038750(k)*A038750(n-k); od; RETURN(s); fi; fi; end;
CROSSREFS
KEYWORD
nonn
AUTHOR
N. J. A. Sloane, May 03 2000
STATUS
approved
A variant of the recurrence for A001190.
+20
2
0, 1, 1, 0, 1, 1, 2, 3, 6, 9, 18, 30, 60, 105, 210, 381, 765, 1425, 2868, 5454, 11004, 21210, 42930, 83673, 169851, 333843, 679602, 1345476, 2745636, 5467275, 11182365, 22379895, 45866418, 92180781, 189275955, 381831396, 785328636
OFFSET
0,7
MAPLE
A038751 := proc(n) option remember; local s, k; if n<=1 then RETURN(n); else s := 0; if n mod 2 = 0 then s := A038751(n/2) * (A038751(n/2) + 1)/2; for k from 1 to n/2 - 1 do s := s + A038751(k) * A038751(n - k); od; RETURN(s); else for k from 1 to (n - 1)/2 - 1 do s := s + A038751(k) * A038751(n - k); od; RETURN(s); fi; fi; end;
CROSSREFS
KEYWORD
nonn
AUTHOR
N. J. A. Sloane, May 03 2000
STATUS
approved
Least number with the prime signature of the n-th Wedderburn-Etherington number (A001190).
+20
2
1, 1, 1, 2, 2, 6, 2, 2, 6, 12, 12, 6, 2, 2, 60, 30, 2, 6, 120, 6, 6, 180, 2, 12, 30, 210, 6, 2, 2, 30, 210, 6, 30, 900900, 30, 180, 24, 210, 60060, 210, 13860, 120, 210, 210, 210, 96, 30, 60060, 6126120, 2310, 30, 60, 2310, 2310, 30, 4620, 210, 240, 210, 120, 30, 60, 2, 1260, 30, 30, 2310, 2310, 60, 18480, 30, 2310, 420, 30, 2310, 18480, 30, 3360, 210, 2, 420, 30
OFFSET
1,4
LINKS
FORMULA
a(n) = A046523(A001190(n)).
PROG
(PARI)
{A001190(n) = local(A); if( n<4, n>0, A = vector(n, i, 1); for( i=4, n, A[i] = sum( j=1, (i-1)\2, A[j] * A[i-j]) + if( i%2, 0, A[i/2] * (A[i/2] + 1)/2)); A[n])}; /* Michael Somos, Mar 25 2006 */
A046523(n) = my(f=vecsort(factor(n)[, 2], , 4), p); prod(i=1, #f, (p=nextprime(p+1))^f[i]) \\ Charles R Greathouse IV, Aug 17 2011
for(n=1, 213, write("b278250.txt", n, " ", A278250(n)));
(Scheme) (define (A278250 n) (A046523 (A001190 n)))
CROSSREFS
Cf. also A278258.
KEYWORD
nonn
AUTHOR
Antti Karttunen, Nov 22 2016
STATUS
approved
G.f.: A(x) = x/(1 - x - G001190(x^2)), where G001190 is the g.f. of A001190, the Wedderburn-Etherington numbers (binary rooted trees).
+20
1
1, 1, 2, 3, 6, 10, 19, 33, 62, 110, 204, 366, 675, 1219, 2239, 4059, 7439, 13518, 24737, 45018, 82304, 149924, 273929, 499290, 911902, 1662787, 3036105, 5537577, 10109364, 18441799, 33663239, 61416729, 112099746, 204536183, 373305550, 681166986, 1243173492, 2268490929, 4140035734, 7554756990, 13787320832, 25159612832, 45915363672
OFFSET
1,3
COMMENTS
Not the same as A003237.
FORMULA
G.f. satisfies the following identities:
(1) A(x^2) = A(x)^2 / (1 + 2*A(x) + 2*A(x)^2),
(2) A(-x) = -A(x) / (1 + 2*A(x)),
(3) A(x) + A(-x) = -2*A(x)*A(-x),
(4) A(x)^2 / (1 + 2*A(x)) = A(x^2) / (1 - 2*A(x^2)).
EXAMPLE
A(x) = x + x^2 + 2x^3 + 3x^4 + 6x^5 + 10x^6 + 19x^7 + 33x^8 + ... = x/(1-x -(x^2 + x^4 + x^6 + 2x^8 + 3x^10 + 11x^12 + 23x^14 + ...)).
PROG
(PARI) {a(n) = my(A=x, u, v); for(k=2, n, u=A+x*O(x^k); v=subst(u, x, x^2); A-=x^k*polcoeff(u^2 -v*(1+2*u+2*u^2), k+1)/2); polcoeff(A, n)}
for(n=1, 30, print1(a(n), ", "))
CROSSREFS
KEYWORD
nonn
AUTHOR
Paul D. Hanna, Mar 23 2004
EXTENSIONS
Changed offset to 1 and removed leading zero. - Paul D. Hanna, Aug 16 2016
STATUS
approved
Partial sums of A001190.
+20
0
0, 1, 2, 3, 5, 8, 14, 25, 48, 94, 192, 399, 850, 1833, 4012, 8862, 19767, 44398, 100409, 228321, 521868, 1198025, 2761397, 6387546, 14823925, 34504202, 80530820, 188421429, 441872140, 1038444527, 2445263286, 5768499524, 13631457915, 32263783234, 76478352334
OFFSET
0,3
COMMENTS
The largest rank for some unlabeled binary rooted tree with n leaves (n>0) in a simple bijection between unlabeled binary rooted trees and positive integers. -Noah A Rosenberg, Jun 14 2022
FORMULA
a(n) = Sum_{i=0..n} A001190(i).
CROSSREFS
Cf. A001190.
KEYWORD
nonn
AUTHOR
Jonathan Vos Post, Feb 14 2010
EXTENSIONS
a(25) corrected by Georg Fischer, Aug 28 2020
STATUS
approved
Catalan numbers: C(n) = binomial(2n,n)/(n+1) = (2n)!/(n!(n+1)!).
(Formerly M1459 N0577)
+10
4070
1, 1, 2, 5, 14, 42, 132, 429, 1430, 4862, 16796, 58786, 208012, 742900, 2674440, 9694845, 35357670, 129644790, 477638700, 1767263190, 6564120420, 24466267020, 91482563640, 343059613650, 1289904147324, 4861946401452, 18367353072152, 69533550916004, 263747951750360, 1002242216651368, 3814986502092304
OFFSET
0,3
COMMENTS
These were formerly sometimes called Segner numbers.
A very large number of combinatorial interpretations are known - see references, esp. R. P. Stanley, "Catalan Numbers", Cambridge University Press, 2015. This is probably the longest entry in the OEIS, and rightly so.
The solution to Schröder's first problem: number of ways to insert n pairs of parentheses in a word of n+1 letters. E.g., for n=2 there are 2 ways: ((ab)c) or (a(bc)); for n=3 there are 5 ways: ((ab)(cd)), (((ab)c)d), ((a(bc))d), (a((bc)d)), (a(b(cd))).
Consider all the binomial(2n,n) paths on squared paper that (i) start at (0, 0), (ii) end at (2n, 0) and (iii) at each step, either make a (+1,+1) step or a (+1,-1) step. Then the number of such paths that never go below the x-axis (Dyck paths) is C(n). [Chung-Feller]
Number of noncrossing partitions of the n-set. For example, of the 15 set partitions of the 4-set, only [{13},{24}] is crossing, so there are a(4)=14 noncrossing partitions of 4 elements. - Joerg Arndt, Jul 11 2011
a(n-1) is the number of ways of expressing an n-cycle (123...n) in the symmetric group S_n as a product of n-1 transpositions (u_1,v_1)*(u_2,v_2)*...*(u_{n-1},v_{n-1}) where u_i<v_i and u_k <= u_j for k < j; see example. If the condition is dropped, one obtains A000272. - Joerg Arndt and Greg Stevenson, Jul 11 2011
Noncrossing partitions are partitions of genus 0. - Robert Coquereaux, Feb 13 2024
a(n) is the number of ordered rooted trees with n nodes, not including the root. See the Conway-Guy reference where these rooted ordered trees are called plane bushes. See also the Bergeron et al. reference, Example 4, p. 167. - Wolfdieter Lang, Aug 07 2007
As shown in the paper from Beineke and Pippert (1971), a(n-2)=D(n) is the number of labeled dissections of a disk, related to the number R(n)=A001761(n-2) of labeled planar 2-trees having n vertices and rooted at a given exterior edge, by the formula D(n)=R(n)/(n-2)!. - M. F. Hasler, Feb 22 2012
Shifts one place left when convolved with itself.
For n >= 1, a(n) is also the number of rooted bicolored unicellular maps of genus 0 on n edges. - Ahmed Fares (ahmedfares(AT)my-deja.com), Aug 15 2001
Number of ways of joining 2n points on a circle to form n nonintersecting chords. (If no such restriction imposed, then the number of ways of forming n chords is given by (2n-1)!! = (2n)!/(n!*2^n) = A001147(n).)
Arises in Schubert calculus - see Sottile reference.
Inverse Euler transform of sequence is A022553.
With interpolated zeros, the inverse binomial transform of the Motzkin numbers A001006. - Paul Barry, Jul 18 2003
The Hankel transforms of this sequence or of this sequence with the first term omitted give A000012 = 1, 1, 1, 1, 1, 1, ...; example: Det([1, 1, 2, 5; 1, 2, 5, 14; 2, 5, 14, 42; 5, 14, 42, 132]) = 1 and Det([1, 2, 5, 14; 2, 5, 14, 42; 5, 14, 42, 132; 14, 42, 132, 429]) = 1. - Philippe Deléham, Mar 04 2004
a(n) equals the sum of squares of terms in row n of triangle A053121, which is formed from successive self-convolutions of the Catalan sequence. - Paul D. Hanna, Apr 23 2005
Also coefficients of the Mandelbrot polynomial M iterated an infinite number of times. Examples: M(0) = 0 = 0*c^0 = [0], M(1) = c = c^1 + 0*c^0 = [1 0], M(2) = c^2 + c = c^2 + c^1 + 0*c^0 = [1 1 0], M(3) = (c^2 + c)^2 + c = [0 1 1 2 1], ... ... M(5) = [0 1 1 2 5 14 26 44 69 94 114 116 94 60 28 8 1], ... - Donald D. Cross (cosinekitty(AT)hotmail.com), Feb 04 2005
The multiplicity with which a prime p divides C_n can be determined by first expressing n+1 in base p. For p=2, the multiplicity is the number of 1 digits minus 1. For p an odd prime, count all digits greater than (p+1)/2; also count digits equal to (p+1)/2 unless final; and count digits equal to (p-1)/2 if not final and the next digit is counted. For example, n=62, n+1 = 223_5, so C_62 is not divisible by 5. n=63, n+1 = 224_5, so 5^3 | C_63. - Franklin T. Adams-Watters, Feb 08 2006
Koshy and Salmassi give an elementary proof that the only prime Catalan numbers are a(2) = 2 and a(3) = 5. Is the only semiprime Catalan number a(4) = 14? - Jonathan Vos Post, Mar 06 2006
The answer is yes. Using the formula C_n = binomial(2n,n)/(n+1), it is immediately clear that C_n can have no prime factor greater than 2n. For n >= 7, C_n > (2n)^2, so it cannot be a semiprime. Given that the Catalan numbers grow exponentially, the above consideration implies that the number of prime divisors of C_n, counted with multiplicity, must grow without limit. The number of distinct prime divisors must also grow without limit, but this is more difficult. Any prime between n+1 and 2n (exclusive) must divide C_n. That the number of such primes grows without limit follows from the prime number theorem. - Franklin T. Adams-Watters, Apr 14 2006
The number of ways to place n indistinguishable balls in n numbered boxes B1,...,Bn such that at most a total of k balls are placed in boxes B1,...,Bk for k=1,...,n. For example, a(3)=5 since there are 5 ways to distribute 3 balls among 3 boxes such that (i) box 1 gets at most 1 ball and (ii) box 1 and box 2 together get at most 2 balls:(O)(O)(O), (O)()(OO), ()(OO)(O), ()(O)(OO), ()()(OOO). - Dennis P. Walsh, Dec 04 2006
a(n) is also the order of the semigroup of order-decreasing and order-preserving full transformations (of an n-element chain) - now known as the Catalan monoid. - Abdullahi Umar, Aug 25 2008
a(n) is the number of trivial representations in the direct product of 2n spinor (the smallest) representations of the group SU(2) (A(1)). - Rutger Boels (boels(AT)nbi.dk), Aug 26 2008
The invert transform appears to converge to the Catalan numbers when applied infinitely many times to any starting sequence. - Mats Granvik, Gary W. Adamson and Roger L. Bagula, Sep 09 2008, Sep 12 2008
Limit_{n->oo} a(n)/a(n-1) = 4. - Francesco Antoni (francesco_antoni(AT)yahoo.com), Nov 24 2008
Starting with offset 1 = row sums of triangle A154559. - Gary W. Adamson, Jan 11 2009
C(n) is the degree of the Grassmannian G(1,n+1): the set of lines in (n+1)-dimensional projective space, or the set of planes through the origin in (n+2)-dimensional affine space. The Grassmannian is considered a subset of N-dimensional projective space, N = binomial(n+2,2) - 1. If we choose 2n general (n-1)-planes in projective (n+1)-space, then there are C(n) lines that meet all of them. - Benji Fisher (benji(AT)FisherFam.org), Mar 05 2009
Starting with offset 1 = A068875: (1, 2, 4, 10, 18, 84, ...) convolved with Fine numbers, A000957: (1, 0, 1, 2, 6, 18, ...). a(6) = 132 = (1, 2, 4, 10, 28, 84) dot (18, 6, 2, 1, 0, 1) = (18 + 12 + 8 + 10 + 0 + 84) = 132. - Gary W. Adamson, May 01 2009
Convolved with A032443: (1, 3, 11, 42, 163, ...) = powers of 4, A000302: (1, 4, 16, ...). - Gary W. Adamson, May 15 2009
Sum_{k>=1} C(k-1)/2^(2k-1) = 1. The k-th term in the summation is the probability that a random walk on the integers (beginning at the origin) will arrive at positive one (for the first time) in exactly (2k-1) steps. - Geoffrey Critzer, Sep 12 2009
C(p+q)-C(p)*C(q) = Sum_{i=0..p-1, j=0..q-1} C(i)*C(j)*C(p+q-i-j-1). - Groux Roland, Nov 13 2009
Leonhard Euler used the formula C(n) = Product_{i=3..n} (4*i-10)/(i-1) in his 'Betrachtungen, auf wie vielerley Arten ein gegebenes polygonum durch Diagonallinien in triangula zerschnitten werden könne' and computes by recursion C(n+2) for n = 1..8. (Berlin, 4th September 1751, in a letter to Goldbach.) - Peter Luschny, Mar 13 2010
Let A179277 = A(x). Then C(x) is satisfied by A(x)/A(x^2). - Gary W. Adamson, Jul 07 2010
a(n) is also the number of quivers in the mutation class of type B_n or of type C_n. - Christian Stump, Nov 02 2010
From Matthew Vandermast, Nov 22 2010: (Start)
Consider a set of A000217(n) balls of n colors in which, for each integer k = 1 to n, exactly one color appears in the set a total of k times. (Each ball has exactly one color and is indistinguishable from other balls of the same color.) a(n+1) equals the number of ways to choose 0 or more balls of each color while satisfying the following conditions: 1. No two colors are chosen the same positive number of times. 2. For any two colors (c, d) that are chosen at least once, color c is chosen more times than color d iff color c appears more times in the original set than color d.
If the second requirement is lifted, the number of acceptable ways equals A000110(n+1). See related comments for A016098, A085082. (End)
Deutsch and Sagan prove the Catalan number C_n is odd if and only if n = 2^a - 1 for some nonnegative integer a. Lin proves for every odd Catalan number C_n, we have C_n == 1 (mod 4). - Jonathan Vos Post, Dec 09 2010
a(n) is the number of functions f:{1,2,...,n}->{1,2,...,n} such that f(1)=1 and for all n >= 1 f(n+1) <= f(n)+1. For a nice bijection between this set of functions and the set of length 2n Dyck words, see page 333 of the Fxtbook (see link below). - Geoffrey Critzer, Dec 16 2010
Postnikov (2005) defines "generalized Catalan numbers" associated with buildings (e.g., Catalan numbers of Type B, see A000984). - N. J. A. Sloane, Dec 10 2011
Number of permutations in S(n) for which length equals depth. - Bridget Tenner, Feb 22 2012
a(n) is also the number of standard Young tableau of shape (n,n). - Thotsaporn Thanatipanonda, Feb 25 2012
a(n) is the number of binary sequences of length 2n+1 in which the number of ones first exceed the number of zeros at entry 2n+1. See the example below in the example section. - Dennis P. Walsh, Apr 11 2012
Number of binary necklaces of length 2*n+1 containing n 1's (or, by symmetry, 0's). All these are Lyndon words and their representatives (as cyclic maxima) are the binary Dyck words. - Joerg Arndt, Nov 12 2012
Number of sequences consisting of n 'x' letters and n 'y' letters such that (counting from the left) the 'x' count >= 'y' count. For example, for n=3 we have xxxyyy, xxyxyy, xxyyxy, xyxxyy and xyxyxy. - Jon Perry, Nov 16 2012
a(n) is the number of Motzkin paths of length n-1 in which the (1,0)-steps come in 2 colors. Example: a(4)=14 because, denoting U=(1,1), H=(1,0), and D=(1,-1), we have 8 paths of shape HHH, 2 paths of shape UHD, 2 paths of shape UDH, and 2 paths of shape HUD. - José Luis Ramírez Ramírez, Jan 16 2013
If p is an odd prime, then (-1)^((p-1)/2)*a((p-1)/2) mod p = 2. - Gary Detlefs, Feb 20 2013
Conjecture: For any positive integer n, the polynomial Sum_{k=0..n} a(k)*x^k is irreducible over the field of rational numbers. - Zhi-Wei Sun, Mar 23 2013
a(n) is the size of the Jones monoid on 2n points (cf. A225798). - James Mitchell, Jul 28 2013
For 0 < p < 1, define f(p) = Sum_{n>=0} a(n)*(p*(1-p))^n, then f(p) = min{1/p, 1/(1-p)}, so f(p) reaches its maximum value 2 at p = 0.5, and p*f(p) is constant 1 for 0.5 <= p < 1. - Bob Selcoe, Nov 16 2013 [Corrected by Jianing Song, May 21 2021]
No a(n) has the form x^m with m > 1 and x > 1. - Zhi-Wei Sun, Dec 02 2013
From Alexander Adamchuk, Dec 27 2013: (Start)
Prime p divides a((p+1)/2) for p > 3. See A120303(n) = Largest prime factor of Catalan number.
Reciprocal Catalan Constant C = 1 + 4*sqrt(3)*Pi/27 = 1.80613.. = A121839.
Log(Phi) = (125*C - 55) / (24*sqrt(5)), where C = Sum_{k>=1} (-1)^(k+1)*1/a(k). See A002390 = Decimal expansion of natural logarithm of golden ratio.
3-d analog of the Catalan numbers: (3n)!/(n!(n+1)!(n+2)!) = A161581(n) = A006480(n) / ((n+1)^2*(n+2)), where A006480(n) = (3n)!/(n!)^3 De Bruijn's S(3,n). (End)
For a relation to the inviscid Burgers's, or Hopf, equation, see A001764. - Tom Copeland, Feb 15 2014
From Fung Lam, May 01 2014: (Start)
One class of generalized Catalan numbers can be defined by g.f. A(x) = (1-sqrt(1-q*4*x*(1-(q-1)*x)))/(2*q*x) with nonzero parameter q. Recurrence: (n+3)*a(n+2) -2*q*(2*n+3)*a(n+1) +4*q*(q-1)*n*a(n) = 0 with a(0)=1, a(1)=1.
Asymptotic approximation for q >= 1: a(n) ~ (2*q+2*sqrt(q))^n*sqrt(2*q*(1+sqrt(q))) /sqrt(4*q^2*Pi*n^3).
For q <= -1, the g.f. defines signed sequences with asymptotic approximation: a(n) ~ Re(sqrt(2*q*(1+sqrt(q)))*(2*q+2*sqrt(q))^n) / sqrt(q^2*Pi*n^3), where Re denotes the real part. Due to Stokes' phenomena, accuracy of the asymptotic approximation deteriorates at/near certain values of n.
Special cases are A000108 (q=1), A068764 to A068772 (q=2 to 10), A240880 (q=-3).
(End)
Number of sequences [s(0), s(1), ..., s(n)] with s(n)=0, Sum_{j=0..n} s(j) = n, and Sum_{j=0..k} s(j)-1 >= 0 for k < n-1 (and necessarily Sum_{j=0..n-1} s(j)-1 = 0). These are the branching sequences of the (ordered) trees with n non-root nodes, see example. - Joerg Arndt, Jun 30 2014
Number of stack-sortable permutations of [n], these are the 231-avoiding permutations; see the Bousquet-Mélou reference. - Joerg Arndt, Jul 01 2014
a(n) is the number of increasing strict binary trees with 2n-1 nodes that avoid 132. For more information about increasing strict binary trees with an associated permutation, see A245894. - Manda Riehl, Aug 07 2014
In a one-dimensional medium with elastic scattering (zig-zag walk), first recurrence after 2n+1 scattering events has the probability C(n)/2^(2n+1). - Joachim Wuttke, Sep 11 2014
The o.g.f. C(x) = (1 - sqrt(1-4x))/2, for the Catalan numbers, with comp. inverse Cinv(x) = x*(1-x) and the functions P(x) = x / (1 + t*x) and its inverse Pinv(x,t) = -P(-x,t) = x / (1 - t*x) form a group under composition that generates or interpolates among many classic arrays, such as the Motzkin (Riordan, A005043), Fibonacci (A000045), and Fine (A000957) numbers and polynomials (A030528), and enumerating arrays for Motzkin, Dyck, and Łukasiewicz lattice paths and different types of trees and non-crossing partitions (A091867, connected to sums of the refined Narayana numbers A134264). - Tom Copeland, Nov 04 2014
Conjecture: All the rational numbers Sum_{i=j..k} 1/a(i) with 0 < min{2,k} <= j <= k have pairwise distinct fractional parts. - Zhi-Wei Sun, Sep 24 2015
The Catalan number series A000108(n+3), offset n=0, gives Hankel transform revealing the square pyramidal numbers starting at 5, A000330(n+2), offset n=0 (empirical observation). - Tony Foster III, Sep 05 2016
Hankel transforms of the Catalan numbers with the first 2, 4, and 5 terms omitted give A001477, A006858, and A091962, respectively, without the first 2 terms in all cases. More generally, the Hankel transform of the Catalan numbers with the first k terms omitted is H_k(n) = Product_{j=1..k-1} Product_{i=1..j} (2*n+j+i)/(j+i) [see Cigler (2011), Eq. (1.14) and references therein]; together they form the array A078920/A123352/A368025. - Andrey Zabolotskiy, Oct 13 2016
Presumably this satisfies Benford's law, although the results in Hürlimann (2009) do not make this clear. See S. J. Miller, ed., 2015, p. 5. - N. J. A. Sloane, Feb 09 2017
Coefficients of the generating series associated to the Magmatic and Dendriform operadic algebras. Cf. p. 422 and 435 of the Loday et al. paper. - Tom Copeland, Jul 08 2018
Let M_n be the n X n matrix with M_n(i,j) = binomial(i+j-1,2j-2); then det(M_n) = a(n). - Tony Foster III, Aug 30 2018
Also the number of Catalan trees, or planted plane trees (Bona, 2015, p. 299, Theorem 4.6.3). - N. J. A. Sloane, Dec 25 2018
Number of coalescent histories for a caterpillar species tree and a matching caterpillar gene tree with n+1 leaves (Rosenberg 2007, Corollary 3.5). - Noah A Rosenberg, Jan 28 2019
Finding solutions of eps*x^2+x-1 = 0 for eps small, that is, writing x = Sum_{n>=0} x_{n}*eps^n and expanding, one finds x = 1 - eps + 2*eps^2 - 5*eps^3 + 14*eps^3 - 42*eps^4 + ... with x_{n} = (-1)^n*C(n). Further, letting x = 1/y and expanding y about 0 to find large roots, that is, y = Sum_{n>=1} y_{n}*eps^n, one finds y = 0 - eps + eps^2 - 2*eps^3 + 5*eps^3 - ... with y_{n} = (-1)^n*C(n-1). - Derek Orr, Mar 15 2019
Permutations of length n that produce a bipartite permutation graph of order n [see Knuth (1973), Busch (2006), Golumbic and Trenk (2004)]. - Elise Anderson, R. M. Argus, Caitlin Owens, Tessa Stevens, Jun 27 2019
For n > 0, a random selection of n + 1 objects (the minimum number ensuring one pair by the pigeonhole principle) from n distinct pairs of indistinguishable objects contains only one pair with probability 2^(n-1)/a(n) = b(n-1)/A098597(n), where b is the 0-offset sequence with the terms of A120777 repeated (1,1,4,4,8,8,64,64,128,128,...). E.g., randomly selecting 6 socks from 5 pairs that are black, blue, brown, green, and white, results in only one pair of the same color with probability 2^(5-1)/a(5) = 16/42 = 8/21 = b(4)/A098597(5). - Rick L. Shepherd, Sep 02 2019
See Haran & Tabachnikov link for a video discussing Conway-Coxeter friezes. The Conway-Coxeter friezes with n nontrivial rows are generated by the counts of triangles at each vertex in the triangulations of regular n-gons, of which there are a(n). - Charles R Greathouse IV, Sep 28 2019
For connections to knot theory and scattering amplitudes from Feynman diagrams, see Broadhurst and Kreimer, and Todorov. Eqn. 6.12 on p. 130 of Bessis et al. becomes, after scaling, -12g * r_0(-y/(12g)) = (1-sqrt(1-4y))/2, the o.g.f. (expressed as a Taylor series in Eqn. 7.22 in 12gx) given for the Catalan numbers in Copeland's (Sep 30 2011) formula below. (See also Mizera p. 34, Balduf pp. 79-80, Keitel and Bartosch.) - Tom Copeland, Nov 17 2019
Number of permutations in S_n whose principal order ideals in the weak order are modular lattices. - Bridget Tenner, Jan 16 2020
Number of permutations in S_n whose principal order ideals in the weak order are distributive lattices. - Bridget Tenner, Jan 16 2020
Legendre gives the following formula for computing the square root modulo 2^m:
sqrt(1 + 8*a) mod 2^m = (1 + 4*a*Sum_{i=0..m-4} C(i)*(-2*a)^i) mod 2^m
as cited by L. D. Dickson, History of the Theory of Numbers, Vol. 1, 207-208. - Peter Schorn, Feb 11 2020
a(n) is the number of length n permutations sorted to the identity by a consecutive-132-avoiding stack followed by a classical-21-avoiding stack. - Kai Zheng, Aug 28 2020
Number of non-crossing partitions of a 2*n-set with n blocks of size 2. Also number of non-crossing partitions of a 2*n-set with n+1 blocks of size at most 3, and without cyclical adjacencies. The two partitions can be mapped by rotated Kreweras bijection. - Yuchun Ji, Jan 18 2021
Named by Riordan (1968, and earlier in Mathematical Reviews, 1948 and 1964) after the French and Belgian mathematician Eugène Charles Catalan (1814-1894) (see Pak, 2014). - Amiram Eldar, Apr 15 2021
For n >= 1, a(n-1) is the number of interpretations of x^n is an algebra where power-associativity is not assumed. For example, for n = 4 there are a(3) = 5 interpretations: x(x(xx)), x((xx)x), (xx)(xx), (x(xx))x, ((xx)x)x. See the link "Non-associate powers and a functional equation" from I. M. H. Etherington and the page "Nonassociative Product" from Eric Weisstein's World of Mathematics for detailed information. See also A001190 for the case where multiplication is commutative. - Jianing Song, Apr 29 2022
Number of states in the transition diagram associated with the Laplacian system over the complete graph K_N, corresponding to ordered initial conditions x_1 < x_2 < ... < x_N. - Andrea Arlette España, Nov 06 2022
a(n) is the number of 132-avoiding stabilized-interval-free permutations of size n+1. - Juan B. Gil, Jun 22 2023
Number of rooted polyominoes composed of n triangular cells of the hyperbolic regular tiling with Schläfli symbol {3,oo}. A rooted polyomino has one external edge identified, and chiral pairs are counted as two. A stereographic projection of the {3,oo} tiling on the Poincaré disk can be obtained via the Christensson link. - Robert A. Russell, Jan 27 2024
a(n) is the number of extremely lucky Stirling permutations of order n; i.e., the number of Stirling permutations of order n that have exactly n lucky cars. (see Colmenarejo et al. reference) - Bridget Tenner, Apr 16 2024
REFERENCES
The large number of references and links demonstrates the ubiquity of the Catalan numbers.
R. Alter, Some remarks and results on Catalan numbers, pp. 109-132 in Proceedings of the Louisiana Conference on Combinatorics, Graph Theory and Computer Science. Vol. 2, edited R. C. Mullin et al., 1971.
Miklos Bona, editor, Handbook of Enumerative Combinatorics, CRC Press, 2015, many references.
L. Comtet, Advanced Combinatorics, Reidel, 1974, p. 53.
J. H. Conway and R. K. Guy, The Book of Numbers, New York: Springer-Verlag, 1995, ch. 4, pp. 96-106.
S. J. Cyvin and I. Gutman, Kekulé structures in benzenoid hydrocarbons, Lecture Notes in Chemistry, No. 46, Springer, New York, 1988 (see pp. 183, 196, etc.).
Michael Dairyko, Samantha Tyner, Lara Pudwell, and Casey Wynn, Non-contiguous pattern avoidance in binary trees. Electron. J. Combin. 19 (2012), no. 3, Paper 22, 21 pp. MR2967227.
E. Deutsch, Dyck path enumeration, Discrete Math., 204, 167-202, 1999.
E. Deutsch and L. Shapiro, Seventeen Catalan identities, Bulletin of the Institute of Combinatorics and its Applications, 31, 31-38, 2001.
L. E. Dickson, History of the Theory of Numbers. Carnegie Institute Public. 256, Washington, DC, Vol. 1, 1919; Vol. 2, 1920; Vol. 3, 1923, see vol. 1, 207-208.
Tomislav Doslic and Darko Veljan, Logarithmic behavior of some combinatorial sequences. Discrete Math. 308 (2008), no. 11, 2182-2212. MR2404544 (2009j:05019)
S. Dulucq and J.-G. Penaud, Cordes, arbres et permutations. Discrete Math. 117 (1993), no. 1-3, 89-105.
A. Errera, Analysis situs - Un problème d'énumération, Mémoires Acad. Bruxelles, Classe des sciences, Série 2, Vol. XI, Fasc. 6, No. 1421 (1931), 26 pp.
Ehrenfeucht, Andrzej; Haemer, Jeffrey; Haussler, David. Quasimonotonic sequences: theory, algorithms and applications. SIAM J. Algebraic Discrete Methods 8 (1987), no. 3, 410-429. MR0897739 (88h:06026)
I. M. H. Etherington, Non-associate powers and a functional equation. The Mathematical Gazette, 21 (1937): 36-39; addendum 21 (1937), 153.
I. M. H. Etherington, On non-associative combinations, Proc. Royal Soc. Edinburgh, 59 (Part 2, 1938-39), 153-162.
I. M. H. Etherington, Some problems of non-associative combinations (I), Edinburgh Math. Notes, 32 (1940), pp. i-vi. Part II is by A. Erdelyi and I. M. H. Etherington, and is on pages vii-xiv of the same issue.
K. Fan, Structure of a Hecke algebra quotient, J. Amer. Math. Soc., 10 (1997), 139-167.
Susanna Fishel, Myrto Kallipoliti and Eleni Tzanaki, Facets of the Generalized Cluster Complex and Regions in the Extended Catalan Arrangement of Type A, The electronic Journal of Combinatorics 20(4) (2013), #P7.
D. Foata and D. Zeilberger, A classic proof of a recurrence for a very classical sequence, J. Comb Thy A 80 380-384 1997.
H. G. Forder, Some problems in combinatorics, Math. Gazette, vol. 45, 1961, 199-201.
Fürlinger, J.; Hofbauer, J., q-Catalan numbers. J. Combin. Theory Ser. A 40 (1985), no. 2, 248-264. MR0814413 (87e:05017)
M. Gardner, Time Travel and Other Mathematical Bewilderments, Chap. 20 pp. 253-266, W. H. Freeman NY 1988.
James Gleick, Faster, Vintage Books, NY, 2000 (see pp. 259-261).
M. C. Golumbic and A. N. Trenk, Tolerance graphs, Vol. 89, Cambridge University Press, 2004, pp. 32.
S Goodenough, C Lavault, Overview on Heisenberg—Weyl Algebra and Subsets of Riordan Subgroups, The Electronic Journal of Combinatorics, 22(4) (2015), #P4.16,
H. W. Gould, Research bibliography of two special number sequences, Mathematica Monongaliae, Vol. 12, 1971.
D. Gouyou-Beauchamps, Chemins sous-diagonaux et tableau de Young, pp. 112-125 of "Combinatoire Enumerative (Montreal 1985)", Lect. Notes Math. 1234, 1986.
M. Griffiths, The Backbone of Pascal's Triangle, United Kingdom Mathematics Trust (2008), 53-63 and 85-93.
J. L. Gross and J. Yellen, eds., Handbook of Graph Theory, CRC Press, 2004; p. 530.
N. S. S. Gu, N. Y. Li and T. Mansour, 2-Binary trees: bijections and related issues, Discr. Math., 308 (2008), 1209-1221.
R. K. Guy, Dissecting a polygon into triangles, Research Paper #9, Math. Dept., Univ. Calgary, 1967.
R. K. Guy and J. L. Selfridge, The nesting and roosting habits of the laddered parenthesis. Amer. Math. Monthly 80 (1973), 868-876.
Peter Hajnal and Gabor V. Nagy, A bijective proof of Shapiro's Catalan convolution, Elect. J. Combin., 21 (2014), #P2.42.
F. Harary and E. M. Palmer, Graphical Enumeration, Academic Press, NY, 1973, p. 67, (3.3.23).
F. Harary, G. Prins, and W. T. Tutte, The number of plane trees. Indag. Math. 26, 319-327, 1964.
J. Harris, Algebraic Geometry: A First Course (GTM 133), Springer-Verlag, 1992, pages 245-247.
S. Heubach, N. Y. Li and T. Mansour, Staircase tilings and k-Catalan structures, Discrete Math., 308 (2008), 5954-5964.
Silvia Heubach and Toufik Mansour, Combinatorics of Compositions and Words, CRC Press, 2010.
Higgins, Peter M. Combinatorial results for semigroups of order-preserving mappings. Math. Proc. Camb. Phil. Soc. (1993), 113: 281-296.
B. D. Hughes, Random Walks and Random Environments, Oxford 1995, vol. 1, p. 513, Eq. (7.282).
F. Hurtado, M. Noy, Ears of triangulations and Catalan numbers, Discrete Mathematics, Volume 149, Issues 1-3, Feb 22 1996, Pages 319-324.
M. Janjic, Determinants and Recurrence Sequences, Journal of Integer Sequences, 2012, Article 12.3.5.
R. H. Jeurissen, Raney and Catalan, Discrete Math., 308 (2008), 6298-6307.
M. Kauers and P. Paule, The Concrete Tetrahedron, Springer 2011, p. 36.
Kim, Ki Hang; Rogers, Douglas G.; Roush, Fred W. Similarity relations and semiorders. Proceedings of the Tenth Southeastern Conference on Combinatorics, Graph Theory and Computing (Florida Atlantic Univ., Boca Raton, Fla., 1979), pp. 577-594, Congress. Numer., XXIII-XXIV, Utilitas Math., Winnipeg, Man., 1979. MR0561081 (81i:05013)
Klarner, D. A. A Correspondence Between Sets of Trees. Indag. Math. 31, 292-296, 1969.
M. Klazar, On numbers of Davenport-Schinzel sequences, Discr. Math., 185 (1998), 77-87.
D. E. Knuth, The Art of Computer Programming, 2nd Edition, Vol. 1, Addison-Wesley, 1973, pp. 238.
D. E. Knuth, The Art of Computer Programming, vol. 4A, Combinatorial Algorithms, Section 7.2.1.6 (p. 450).
Thomas Koshy and Mohammad Salmassi, "Parity and Primality of Catalan Numbers", College Mathematics Journal, Vol. 37, No. 1 (Jan 2006), pp. 52-53.
M. Kosters, A theory of hexaflexagons, Nieuw Archief Wisk., 17 (1999), 349-362.
E. Krasko, A. Omelchenko, Brown's Theorem and its Application for Enumeration of Dissections and Planar Trees, The Electronic Journal of Combinatorics, 22 (2015), #P1.17.
C. Krishnamachary and M. Bheemasena Rao, Determinants whose elements are Eulerian, prepared Bernoullian and other numbers, J. Indian Math. Soc., 14 (1922), 55-62, 122-138 and 143-146.
P. Lafar and C. T. Long, A combinatorial problem, Amer. Math. Mnthly, 69 (1962), 876-883.
Laradji, A. and Umar, A. On certain finite semigroups of order-decreasing transformations I, Semigroup Forum 69 (2004), 184-200.
P. J. Larcombe, On pre-Catalan Catalan numbers: Kotelnikow (1766), Mathematics Today, 35 (1999), p. 25.
P. J. Larcombe, On the history of the Catalan numbers: a first record in China, Mathematics Today, 35 (1999), p. 89.
P. J. Larcombe, The 18th century Chinese discovery of the Catalan numbers, Math. Spectrum, 32 (1999/2000), 5-7.
P. J. Larcombe and P. D. C. Wilson, On the trail of the Catalan sequence, Mathematics Today, 34 (1998), 114-117.
P. J. Larcombe and P. D. C. Wilson, On the generating function of the Catalan sequence: a historical perspective, Congress. Numer., 149 (2001), 97-108.
G. S. Lueker, Some techniques for solving recurrences, Computing Surveys, 12 (1980), 419-436.
J. J. Luo, Antu Ming, the first inventor of Catalan numbers in the world [in Chinese], Neimenggu Daxue Xuebao, 19 (1998), 239-245.
C. L. Mallows, R. J. Vanderbei, Which Young Tableaux Can Represent an Outer Sum?, Journal of Integer Sequences, Vol. 18, 2015, #15.9.1.
Toufik Mansour, Matthias Schork, and Mark Shattuck, Catalan numbers and pattern restricted set partitions. Discrete Math. 312(2012), no. 20, 2979-2991. MR2956089
Toufik Mansour and Simone Severini, Enumeration of (k,2)-noncrossing partitions, Discrete Math., 308 (2008), 4570-4577.
M. E. Mays and Jerzy Wojciechowski, A determinant property of Catalan numbers. Discrete Math. 211, No. 1-3, 125-133 (2000). Zbl 0945.05037
D. Merlini, R. Sprugnoli and M. C. Verri, The tennis ball problem, J. Combin. Theory, A 99 (2002), 307-344.
A. Milicevic and N. Trinajstic, "Combinatorial Enumeration in Chemistry", Chem. Modell., Vol. 4, (2006), pp. 405-469.
Miller, Steven J., ed. Benford's Law: Theory and Applications. Princeton University Press, 2015.
David Molnar, "Wiggly Games and Burnside's Lemma", Chapter 8, The Mathematics of Various Entertaining Subjects: Volume 3 (2019), Jennifer Beineke & Jason Rosenhouse, eds. Princeton University Press, Princeton and Oxford, p. 102.
C. O. Oakley and R. J. Wisner, Flexagons, Amer. Math. Monthly, 64 (1957), 143-154.
A. Panholzer and H. Prodinger, Bijections for ternary trees and non-crossing trees, Discrete Math., 250 (2002), 181-195 (see Eq. 4).
Papoulis, Athanasios. "A new method of inversion of the Laplace transform."Quart. Appl. Math 14.405-414 (1957): 124.
S. G. Penrice, Stacks, bracketings and CG-arrangements, Math. Mag., 72 (1999), 321-324.
C. A. Pickover, Wonders of Numbers, Chap. 71, Oxford Univ. Press NY 2000.
Clifford A. Pickover, A Passion for Mathematics, Wiley, 2005; see p. 71.
G. Pólya, On the number of certain lattice polygons. J. Combinatorial Theory 6 1969 102-105. MR0236031 (38 #4329)
C. Pomerance, Divisors of the middle binomial coefficient, Amer. Math. Monthly, 112 (2015), 636-644.
Jocelyn Quaintance and Harris Kwong, A combinatorial interpretation of the Catalan and Bell number difference tables, Integers, 13 (2013), #A29.
Ronald C. Read, "The Graph Theorists who Count -- and What They Count", in 'The Mathematical Gardner', in D. A. Klarner, Ed., pp. 331-334, Wadsworth CA 1989.
J. Riordan, Combinatorial Identities, Wiley, 1968, p. 101.
J. Riordan, The distribution of crossings of chords joining pairs of 2n points on a circle, Math. Comp., 29 (1975), 215-222.
T. Santiago Costa Oliveira, "Catalan traffic" and integrals on the Grassmannian of lines, Discr. Math., 308 (2007), 148-152.
A. Sapounakis, I. Tasoulas and P. Tsikouras, Counting strings in Dyck paths, Discrete Math., 307 (2007), 2909-2924.
E. Schröder, Vier combinatorische Probleme, Z. f. Math. Phys., 15 (1870), 361-376.
Shapiro, Louis W. Catalan numbers and "total information" numbers. Proceedings of the Sixth Southeastern Conference on Combinatorics, Graph Theory, and Computing (Florida Atlantic Univ., Boca Raton, Fla., 1975), pp. 531-539. Congressus Numerantium, No. XIV, Utilitas Math., Winnipeg, Man., 1975. MR0398853 (53 #2704).
L. W. Shapiro, A short proof of an identity of Touchard's concerning Catalan numbers, J. Combin. Theory, A 20 (1976), 375-376.
L. W. Shapiro and C. J. Wang, Generating identities via 2 X 2 matrices, Congressus Numerantium, 205 (2010), 33-46.
L. W. Shapiro, W.-J. Woan and S. Getu, The Catalan numbers via the World Series, Math. Mag., 66 (1993), 20-22.
D. M. Silberger, Occurrences of the integer (2n-2)!/n!(n-1)!, Roczniki Polskiego Towarzystwa Math. 13 (1969): 91-96.
N. J. A. Sloane, A Handbook of Integer Sequences, Academic Press, 1973 (includes this sequence).
N. J. A. Sloane and Simon Plouffe, The Encyclopedia of Integer Sequences, Academic Press, 1995 (includes this sequence).
S. Snover and S. Troyer, Multidimensional Catalan numbers, Abstracts 848-05-94 and 848-05-95, 848th Meeting, Amer. Math. Soc., Worcester Mass., March 15-16, 1989.
Solomon, A. Catalan monoids, monoids of local endomorphisms and their presentations. Semigroup Forum 53 (1996), 351-368.
R. P. Stanley, Enumerative Combinatorics, Wadsworth, Vol. 1, 1986, Vol. 2, 1999; see especially Chapter 6.
R. P. Stanley, Recent Progress in Algebraic Combinatorics, Bull. Amer. Math. Soc., 40 (2003), 55-68.
Richard P. Stanley, "Catalan Numbers", Cambridge University Press, 2015.
J. J. Sylvester, On reducible cyclodes, Coll. Math. Papers, Vol. 2, see especially page 670, where Catalan numbers appear.
Thiel, Marko. "A new cyclic sieving phenomenon for Catalan objects." Discrete Mathematics 340.3 (2017): 426-429.
I. Vun and P. Belcher, Catalan numbers, Mathematical Spectrum, 30 (1997/1998), 3-5.
D. Wells, Penguin Dictionary of Curious and Interesting Numbers, Entry 42 p 121, Penguin Books, 1987.
D. B. West, Combinatorial Mathematics, Cambridge, 2021, p. 41.
J. Wuttke, The zig-zag walk with scattering and absorption on the real half line and in a lattice model, J. Phys. A 47 (2014), 215203, 1-9.
LINKS
Robert G. Wilson v, Table of n, a(n) for n = 0..1000 (first 200 terms from N. J. A. Sloane, first 351 from K. D. Bajpai)
James Abello, The weak Bruhat order of S_Sigma, consistent sets, and Catalan numbers, SIAM J. Discrete Math. 4 (1991), 1-16.
Marco Abrate, Stefano Barbero, Umberto Cerruti and Nadir Murru, Colored compositions, Invert operator and elegant compositions with the "black tie", Discrete Mathematics, 335 (2014), 1-7.
M. Aigner, Enumeration via ballot numbers, Discrete Mathematics, Vol. 308, No. 12 (2008), 2544-2563.
R. Alter and K. K. Kubota, Prime and prime power divisibility of Catalan numbers, Journal of Combinatorial Theory, Series A, Vol. 15, No. 3 (1973), 243-256.
M. J. H. Al-Kaabi, D. Manchon and F. Patras, Chapter 2 of Monomial bases and pre-Lie structure for free Lie algebras, arXiv:1708.08312 [math.RA], 2017, See p. 3.
P. C. Allaart and K. Kawamura, The Takagi function: a survey, Real Analysis Exchange, 37 (2011/12), 1-54; arXiv:1110.1691 [math.CA]. See Section 3.2.
N. Alon, Y. Caro and I. Krasikov, Bisection of trees and sequences, Discrete Math., 114 (1993), 3-7. (See Lemma 2.1.)
G. Alvarez, J. E. Bergner and R. Lopez, Action graphs and Catalan numbers, arXiv preprint arXiv:1503.00044 [math.CO], 2015.
George E. Andrews, Catalan numbers, q-Catalan numbers and hypergeometric series, Journal of Combinatorial Theory, Series A, Vol. 44, No. 2 (1987), 267-273.
Federico Ardila, Catalan Numbers, 2016.
Drew Armstrong, Generalized Noncrossing Partitions and Combinatorics of Coxeter Groups, Mem. Amer. Math. Soc. 202 (2009), no. 949, x+159. MR 2561274 16; See Table 2.8. Also arXiv:math/0611106, 2006-2007.
Joerg Arndt, Matters Computational (The Fxtbook), p. 333 and p. 337.
Yu Hin (Gary) Au, Fatemeh Bagherzadeh, Murray R. Bremner, Enumeration and Asymptotic Formulas for Rectangular Partitions of the Hypercube, arXiv:1903.00813 [math.CO], 2019.
Jean-Christophe Aval, Multivariate Fuss-Catalan numbers, arXiv:0711.0906v1, Discrete Math., 308 (2008), 4660-4669.
M. Azaola and F. Santos, The number of triangulations of the cyclic polytope C(n,n-4), Discrete Comput. Geom., 27 (2002), 29-48. (C(n) = number of triangulations of cyclic polytope C(n,2).)
R. Bacher and C. Krattenthaler, Chromatic statistics for triangulations and Fuss-Catalan complexes, Electronic Journal of Combinatorics, Vol. 18, No. 1 (2011), #P152.
D. F. Bailey, Counting Arrangements of 1's and -1's, Mathematics Magazine 69(2) 128-131 1996.
I. Bajunaid et al., Function Series, Catalan Numbers, and Random Walks on Trees, The American Mathematical Monthly, Vol. 112, No. 9 (2005), 765-785.
P. Balduf, The propagator and diffeomorphisms of an interacting field theory, Master's thesis, submitted to the Institut für Physik, Mathematisch-Naturwissenschaftliche Fakultät, Humboldt-Universität, Berlin, 2018.
C. Banderier, M. Bousquet-Mélou, A. Denise, P. Flajolet, D. Gardy and D. Gouyou-Beauchamps, Generating Functions for Generating Trees, Discrete Mathematics 246(1-3), March 2002, pp. 29-55.
C. Banderier, M. Bousquet-Mélou, A. Denise, P. Flajolet, D. Gardy and D. Gouyou-Beauchamps, INRIA report 3661, preprint for FPSAC 99, Generating Functions for Generating Trees, Discrete Mathematics 246(1-3), March 2002, pp. 29-55.
C. Banderier, C. Krattenthaler, A. Krinik, D. Kruchinin, V. Kruchinin, D. Nguyen, and M. Wallner, Explicit formulas for enumeration of lattice paths: basketball and the kernel method, arXiv preprint arXiv:1609.06473 [math.CO], 2016.
Mohamed Barakat, Reimer Behrends, Christopher Jefferson, Lukas Kühne and Martin Leuner, On the generation of rank 3 simple matroids with an application to Terao's freeness conjecture, arXiv:1907.01073 [math.CO], 2019.
S. Barbero, U. Cerruti and N. Murru, A Generalization of the Binomial Interpolated Operator and its Action on Linear Recurrent Sequences, J. Int. Seq. 13 (2010) # 10.9.7, theorem 17.
E. Barcucci, A. Del Lungo, E. Pergola and R. Pinzani, Permutations avoiding an increasing number of length-increasing forbidden subsequences, Discrete Mathematics and Theoretical Computer Science 4, 2000, 31-44.
E. Barcucci, A. Del Lungo, E. Pergola and R. Pinzani, Some permutations with forbidden subsequences and their inversion number, Discrete Mathematics, Vol. 234, No. 1-3 (2001), 1-15.
E. Barcucci, A. Frosini and S. Rinaldi, On directed-convex polyominoes in a rectangle, Discrete Mathematics, Vol. 298, No. 1-3 (2005), 62-78.
Jean-Luc Baril, Classical sequences revisited with permutations avoiding dotted pattern, Electronic Journal of Combinatorics, 18 (2011), #P178.
Jean-Luc Baril, Avoiding patterns in irreducible permutations, Discrete Mathematics and Theoretical Computer Science, Vol 17, No 3 (2016).
Jean-Luc Baril, David Bevan and Sergey Kirgizov, Bijections between directed animals, multisets and Grand-Dyck paths, arXiv:1906.11870 [math.CO], 2019.
Jean-Luc Baril, C. Khalil and V. Vajnovszki, Catalan and Schröder permutations sortable by two restricted stacks, arXiv:2004.01812 [cs.DM], 2020.
Jean-Luc Baril, Sergey Kirgizov and Armen Petrossian, Motzkin paths with a restricted first return decomposition, Integers (2019) Vol. 19, A46.
Jean-Luc Baril, Sergey Kirgizov, José L. Ramírez, and Diego Villamizar, The Combinatorics of Motzkin Polyominoes, arXiv:2401.06228 [math.CO], 2024. See page 1.
Jean-Luc Baril, Sergey Kirgizov and Vincent Vajnovszki, Descent distribution on Catalan words avoiding a pattern of length at most three, arXiv:1803.06706 [math.CO], 2018.
Jean-Luc Baril, T. Mansour and A. Petrossian, Equivalence classes of permutations modulo excedances, 2014.
Jean-Luc Baril and J.-M. Pallo, Motzkin subposet and Motzkin geodesics in Tamari lattices, 2013.
Jean-Luc Baril and Armen Petrossian, Equivalence classes of Dyck paths modulo some statistics, Discrete Mathematics, Vol. 338, No. 4 (2015), 655-660.
Marilena Barnabei, Flavio Bonetti, and Niccolò Castronuovo, Motzkin and Catalan Tunnel Polynomials, J. Int. Seq., Vol. 21 (2018), Article 18.8.8.
Paul Barry, A Catalan Transform and Related Transformations on Integer Sequences, Journal of Integer Sequences, Vol. 8 (2005), Article 05.4.5.
Paul Barry, On Integer-Sequence-Based Constructions of Generalized Pascal Triangles, Journal of Integer Sequences, Vol. 9 (2006), Article 06.2.4.
Paul Barry, Three Études on a sequence transformation pipeline, arXiv:1803.06408 [math.CO], 2018.
Paul Barry, Generalized Eulerian Triangles and Some Special Production Matrices, arXiv:1803.10297 [math.CO], 2018.
Paul Barry, Riordan arrays, generalized Narayana triangles, and series reversion, Linear Algebra and its Applications, 491 (2016), 343-385.
Paul Barry, The Gamma-Vectors of Pascal-like Triangles Defined by Riordan Arrays, arXiv:1804.05027 [math.CO], 2018.
Paul Barry and A. Hennessy, The Euler-Seidel Matrix, Hankel Matrices and Moment Sequences, J. Int. Seq. 13 (2010) # 10.8.2
Paul Barry, Invariant number triangles, eigentriangles and Somos-4 sequences, arXiv:1107.5490 [math.CO], 2011.
Paul Barry, Riordan Pseudo-Involutions, Continued Fractions and Somos 4 Sequences, arXiv:1807.05794 [math.CO], 2018.
Paul Barry, The Central Coefficients of a Family of Pascal-like Triangles and Colored Lattice Paths, J. Int. Seq., Vol. 22 (2019), Article 19.1.3.
Paul Barry, Generalized Catalan Numbers Associated with a Family of Pascal-like Triangles, J. Int. Seq., Vol. 22 (2019), Article 19.5.8.
Paul Barry, A Note on Riordan Arrays with Catalan Halves, arXiv:1912.01124 [math.CO], 2019.
Paul Barry, Riordan arrays, the A-matrix, and Somos 4 sequences, arXiv:1912.01126 [math.CO], 2019.
Paul Barry, Chebyshev moments and Riordan involutions, arXiv:1912.11845 [math.CO], 2019.
Paul Barry, Characterizations of the Borel triangle and Borel polynomials, arXiv:2001.08799 [math.CO], 2020.
A. M. Baxter and L. K. Pudwell, Ascent sequences avoiding pairs of patterns, 2014.
Margaret Bayer and Keith Brandt, The Pill Problem, Lattice Paths and Catalan Numbers, preprint, Mathematics Magazine, Vol. 87, No. 5 (December 2014), pp. 388-394.
Christian Bean, A. Claesson and H. Ulfarsson, Simultaneous Avoidance of a Vincular and a Covincular Pattern of Length 3, arXiv preprint arXiv:1512.03226 [math.CO], 2015.
Nicholas R. Beaton, Mathilde Bouvel, Veronica Guerrini and Simone Rinaldi, Enumerating five families of pattern-avoiding inversion sequences; and introducing the powered Catalan numbers, arXiv:1808.04114 [math.CO], 2018.
L. W. Beineke and R. E. Pippert, Enumerating labeled k-dimensional trees and ball dissections, pp. 12-26 of Proceedings of Second Chapel Hill Conference on Combinatorial Mathematics and its Applications, University of North Carolina, Chapel Hill, 1970. Reprinted in Math. Annalen 191 (1971), 87-98.
E. T. Bell, The Iterated Exponential Integers, Annals of Mathematics, Vol. 39, No. 3 (1938), 539-557.
Maciej Bendkowski and Pierre Lescanne, Combinatorics of explicit substitutions, arXiv:1804.03862 [cs.LO], 2018.
Matthew Bennett, Vyjayanthi Chari, R. J. Dolbin and Nathan Manning, Square partitions and Catalan numbers, arXiv:0912.4983 [math.RT], 2009.
F. Bergeron, G. Labelle and P. Leroux, Combinatorial Species and Tree-like Structures, Encyclopedia of Mathematics and its Applications 67 (1997), see pp. 163, 167, 168, 252, 256, 291.
Julia E. Bergner, Cedric Harper, Ryan Keller and Mathilde Rosi-Marshall, Action graphs, planar rooted forests, and self-convolutions of the Catalan numbers, arXiv:1807.03005 [math.CO], 2018.
E. E. Bernard and P. D. A. Mole, Generating strategies for continuous separation processes, Computer J., 2 (1959), 87-89. [Annotated scanned copy]
E. E. Bernard and P. D. A. Mole, Generating Strategies for Continuous Separation Processes, The Computer Journal, Vol. 2, No. 2 (1959), 87-89.
F. R. Bernhart, Catalan, Motzkin and Riordan numbers, Discrete Mathematics, Vol. 204, No. 1-3 (1999), 73-112.
A. Bernini, F. Disanto, R. Pinzani and S. Rinaldi, Permutations Defining Convex Permutominoes, Journal of Integer Sequences 10 (2007), Article 07.9.7.
M. Bernstein and N. J. A. Sloane, Some canonical sequences of integers, Linear Alg. Applications, 226-228 (1995), 57-72; erratum 320 (2000), 210. [Link to arXiv version]
M. Bernstein and N. J. A. Sloane, Some canonical sequences of integers, Linear Alg. Applications, 226-228 (1995), 57-72; erratum 320 (2000), 210. [Link to Lin. Alg. Applic. version together with omitted figures].
D. Bessis, C. Itzykson, and J. B. Zuber, Quantum Field Theory Techniques in Graphical Enumeration, Adv. in Applied Math., Vol. I, Issue 3, Jun 1980, p. 109-157.
D. Birmajer, J. B. Gil, J. O. Tirrell, and M. D. Weiner, Pattern-avoiding stabilized-interval-free permutations, arXiv:2306.03155 [math.CO], 2023.
Aubrey Blecher, Charlotte Brennan and Arnold Knopfmacher, Water capacity of Dyck paths, Advances in Applied Mathematics (2019) Vol. 112, 101945.
Natasha Blitvić and Einar Steingrímsson, Permutations, moments, measures, arXiv:2001.00280 [math.CO], 2020.
Miklós Bóna, Surprising Symmetries in Objects Counted by Catalan Numbers, Electronic J. Combin., 19 (2012), P62.
M. Bona and B. E. Sagan, On Divisibility of Narayana Numbers by Primes, Journal of Integer Sequences 8 (2005), Article 05.2.4.
T. Bourgeron, Montagnards et polygones [dead link]
Michel Bousquet and Cedric Lamathe, On symmetric structures of order two, Discrete Mathematics and Theoretical Computer Science, Vol. 10, No. 2 (2008), 153-176.
Mireille Bousquet-Mélou, Sorted and/or sortable permutations, Discrete Mathematics, vol.225, no.1-3, pp.25-50, (2000).
M. Bousquet-Mélou and Gilles Schaeffer, Walks on the slit plane, Probability Theory and Related Fields, Vol. 124, no. 3 (2002), 305-344.
M. Bouvel, V. Guerrini and S. Rinaldi, Slicings of parallelogram polyominoes, or how Baxter and Schroeder can be reconciled, arXiv preprint arXiv:1511.04864 [math.CO], 2015.
G. Bowlin and M. G. Brin, Coloring Planar Graphs via Colored Paths in the Associahedra, arXiv preprint arXiv:1301.3984 [math.CO], 2013.
Douglas Bowman and Alon Regev, Counting symmetry classes of dissections of a convex regular polygon, arXiv preprint arXiv:1209.6270 [math.CO], 2012.
Richard Brak, A Universal Bijection for Catalan Structures, arXiv:1808.09078 [math.CO], 2018.
D. Broadhurst and D. Kreimer, Knots and Numbers in phi^4 Theory to 7 Loops and Beyond, arXiv:9504352 [hep-ph], 1995.
K. S. Brown's Mathpages at Math Forum, The Meanings of Catalan Numbers
W. G. Brown, Historical Note on a Recurrent Combinatorial Problem, The American Mathematical Monthly, Vol. 72, No. 9 (1965), 973-977.
W. G. Brown, Historical note on a recurrent combinatorial problem, Amer. Math. Monthly, 72 (1965), 973-977. [Annotated scanned copy]
Kevin Buchin, Man-Kwun Chiu, Stefan Felsner, Günter Rote and André Schulz, The Number of Convex Polyominoes with Given Height and Width, arXiv:1903.01095 [math.CO], 2019.
B. Bukh, PlanetMath.org, Catalan numbers
Alexander Burstein, Sergi Elizalde and Toufik Mansour, Restricted Dumont permutations, Dyck paths and noncrossing partitions, arXiv:math/0610234 [math.CO], 2006.
A. H. Busch, A characterization of triangle-free tolerance graphs, Discrete Applied Mathematics 154, no. 3, 2006 pp. 471.
W. Butler, A. Kalotay and N. J. A. Sloane, Correspondence, 1974
W. Butler and N. J. A. Sloane, Correspondence, 1974
Libor Caha and Daniel Nagaj, The pair-flip model: a very entangled translationally invariant spin chain, arXiv:1805.07168 [quant-ph], 2018.
Fangfang Cai, Qing-Hu Hou, Yidong Sun and Arthur L.B. Yang, Combinatorial identities related to 2X2 submatrices of recursive matrices, arXiv:1808.05736 [math.CO], 2018.
David Callan, A Combinatorial Interpretation for a Super-Catalan Recurrence, Journal of Integer Sequences, Vol. 8 (2005), Article 05.1.8.
D. Callan, A Combinatorial Interpretation of a Catalan Numbers Identity, Mathematics Magazine, Vol. 72, No. 4 (1999), 295-298.
David Callan, A Combinatorial Interpretation of the Eigensequence for Composition, Journal of Integer Sequences, Vol. 9 (2006), Article 06.1.4.
D. Callan, A variant of Touchard's Catalan number identity, arXiv preprint arXiv:1204.5704 [math.CO], 2012.
D. Callan, Pattern avoidance in "flattened" partitions, Discrete Mathematics, Vol. 309, No. 12 (2009), 4187-4191.
D. Callan, The Maximum Associativeness of Division: 11091, The American Mathematical Monthly, Vol. 113, No. 5 (2006), 462-463.
David Callan and Emeric Deutsch, The Run Transform, Discrete Math. 312 (2012), no. 19, 2927-2937, arXiv:1112.3639 [math.CO], 2011.
Naiomi T. Cameron and Asamoah Nkwanta, On Some (Pseudo) Involutions in the Riordan Group, Journal of Integer Sequences, Vol. 8 (2005), Article 05.3.7.
Peter J. Cameron, Some treelike objects, The Quarterly Journal of Mathematics, Vol. 38, No. 2 (1987), 155-183. See pp. 155, 162.
P. J. Cameron, Sequences realized by oligomorphic permutation groups, J. Integ. Seqs. Vol. 3 (2000), #00.1.5.
A. Cayley, On the partitions of a polygon, Proc. London Math. Soc., 22 (1891), 237-262 = Collected Mathematical Papers. Vols. 1-13, Cambridge Univ. Press, London, 1889-1897, Vol. 13, pp. 93ff.
F. Cazals, Combinatorics of Non-Crossing Configurations, Studies in Automatic Combinatorics, Volume II (1997).
Giulio Cerbai, Anders Claesson, Luca Ferrari and Einar Steingrímsson, Sorting with pattern-avoiding stacks: the 132-machine, arXiv:2006.05692 [math.CO], 2020.
José Luis Cereceda, An alternative recursive formula for the sums of powers of integers, arXiv:1510.00731 [math.CO], 2015.
G. Chatel and V. Pilaud, The Cambrian and Baxter-Cambrian Hopf Algebras, arXiv preprint arXiv:1411.3704 [math.CO], 2014.
Cedric Chauve, Yann Ponty and Michael Wallner, Counting and sampling gene family evolutionary histories in the duplication-loss and duplication-loss-transfer models, arXiv:1905.04971 [math.CO], 2019.
Young-Ming Chen, The Chung-Feller theorem revisited, Discrete Mathematics, Vol. 308, No. 7 (2008), 1328-1329.
Peter Cholak and Ludovic Patey, Thin set theorems and cone avoidance, arXiv:1812.00188 [math.LO], 2018.
Wun-Seng Chou, Tian-Xiao He and Peter J.-S. Shiue, On the Primality of the Generalized Fuss-Catalan Numbers, Journal of Integer Sequences, Vol. 21 (2018), Article 18.2.1.
Malin Christensson, Make hyperbolic tilings of images, web page, 2019.
Julie Christophe, Jean-Paul Doignon and Samuel Fiorini, Counting Biorders, J. Integer Seqs., Vol. 6, 2003.
Kai Lai Chung and W. Feller, On Fluctuations in Coin-Tossing, Proceedings of the National Academy of Sciences of the United States of America, Vol. 35, No. 10 (1949), 605-608.
J. Cigler, Some nice Hankel determinants, arXiv:1109.1449 [math.CO], 2011.
Johann Cigler and Christian Krattenthaler, Hankel determinants of linear combinations of moments of orthogonal polynomials, arXiv:2003.01676 [math.CO], 2020.
Laura Colmenarejo, Aleyah Dawkins, Jennifer Elder, Pamela E. Harris, Kimberly J. Harry, Selvi Kara, Dorian Smith, and Bridget Eileen Tenner, On the lucky and displacement statistics of Stirling permutations, arXiv:2403.03280 [math.CO], 2024.
CombOS - Combinatorial Object Server, Generate Dyck paths
Aldo Conca, Hans-Christian Herbig and Srikanth B. Iyengar, Koszul properties of the moment map of some classical representations, arXiv:1705.02688 [math.AC], 2017, also Collectanea Mathematica (2018) 69.3, 337-357.
Harry Crane, Left-right arrangements, set partitions, and pattern avoidance, Australasian Journal of Combinatorics, 61(1) (2015), 57-72.
Alissa S. Crans, A surreptitious sequence: the Catalan numbers video (2014).
Danielle Cressman, Jonathan Lin, An Nguyen and Luke Wiljanen, Generalized Action Graphs, poster, (2020).
S. J. Cyvin, J. Brunvoll, E. Brendsdal, B. N. Cyvin and E. K. Lloyd, Enumeration of polyene hydrocarbons: a complete mathematical solution, J. Chem. Inf. Comput. Sci., 35 (1995) 743-751. [Annotated scanned copy]
Dennis E. Davenport, Lara K. Pudwell, Louis W. Shapiro and Leon C. Woodson, The Boundary of Ordered Trees, Journal of Integer Sequences, Vol. 18 (2015), Article 15.5.8.
Dennis E. Davenport, Louis W. Shapiro and Leon C. Woodson, A bijection between the triangulations of convex polygons and ordered trees, Integers (2020) Vol. 20, Article #A8.
T. Davis, Catalan Numbers
Colin Defant, Catalan Intervals and Uniquely Sorted Permutations, arXiv:1904.02627 [math.CO], 2019.
C. Defant and K. Zheng, Stack-Sorting with Consecutive-Pattern-Avoiding Stacks, arXiv:2008.12297 [math.CO], 2020.
E. Deutsch and B. E. Sagan, Congruences for Catalan and Motzkin numbers and related sequences, J. Num. Theory 117 (2006), 191-215.
E. Deutsch and L. Shapiro, A survey of the Fine numbers, Discrete Math., 241 (2001), 241-265.
Jimmy Devillet and Bruno Teheux, Associative, idempotent, symmetric, and order-preserving operations on chains, arXiv:1805.11936 [math.RA], 2018.
R. M. Dickau, Catalan numbers
T. Dokos and I. Pak, The expected shape of random doubly alternating Baxter permutations, arXiv:1401.0770 [math.CO], 2014.
C. Domb & A. J. Barrett, Enumeration of ladder graphs, Discrete Math. 9 (1974), 341-358. (Annotated scanned copy)
C. Domb & A. J. Barrett, Notes on Table 2 in "Enumeration of ladder graphs", Discrete Math. 9 (1974), 55. (Annotated scanned copy)
T. Doslic, Handshakes across a (round) table, JIS 13 (2010) #10.2.7.
Eric S. Egge, Kailee Rubin, Snow Leopard Permutations and Their Even and Odd Threads, arXiv:1508.05310 [math.CO], 2015.
Roger B. Eggleton and Richard K. Guy, Catalan strikes again! How likely is a function to be convex?, Mathematics Magazine, 61 (1988): 211-219.
Shalosh B. Ekhad, Nathaniel Shar, and Doron Zeilberger, The number of 1...d-avoiding permutations of length d+r for SYMBOLIC d but numeric r, arXiv:1504.02513 [math.CO], 2015.
Gennady Eremin, Factoring Catalan numbers, arXiv:1908.03752 [math.NT], 2019.
A. España, X. Leoncini, and E. Ugalde, Combinatorics of the paths towards synchronization, arXiv:2205.05948 [math.DS], 2022.
I. M. H. Etherington, Non-associate powers and a functional equation, Math. Gaz., 21 (1937), 36-39. [Annotated scanned copy]
I. M. H. Etherington, On non-associative combinations, Proc. Royal Soc. Edinburgh, 59 (Part 2, 1938-39), 153-162. [Annotated scanned copy]
I. M. H. Etherington, Some problems of non-associative combinations (I), Edinburgh Math. Notes, 32 (1940), pp. i-vi. [Annotated scanned copy]. Part II [not scanned] is by A. Erdelyi and I. M. H. Etherington, and is on pages vii-xiv of the same issue.
Jackson Evoniuk, Steven Klee and Van Magnan, Enumerating Minimal Length Lattice Paths, J. Int. Seq., Vol. 21 (2018), Article 18.3.6.
Luca Ferrari and Emanuele Munarini, Enumeration of edges in some lattices of paths, arXiv preprint arXiv:1203.6792 [math.CO], 2012.
FindStat - Combinatorial Statistic Finder, The number of stack-sorts needed to sort a permutation
D. C. Fielder & C. O. Alford, An investigation of sequences derived from Hoggatt Sums and Hoggatt Triangles, Application of Fibonacci Numbers, 3 (1990) 77-88. Proceedings of 'The Third Annual Conference on Fibonacci Numbers and Their Applications,' Pisa, Italy, July 25-29, 1988. (Annotated scanned copy)
Philippe Flajolet, Éric Fusy, Xavier Gourdon, Daniel Panario and Nicolas Pouyanne, A hybrid of Darboux's method and singularity analysis in combinatorial asymptotics, arXiv:math/0606370 [math.CO], 2006.
Philippe Flajolet, Xavier Gourdon, and Philippe Dumas, Mellin transforms and asymptotics: harmonic sums, Special volume on mathematical analysis of algorithms. Theoret. Comput. Sci. 144 (1995), no. 1-2, 3-58.
P. Flajolet and R. Sedgewick, Analytic Combinatorics, 2009; see page 18, 35
D. Foata and G.-N. Han, The doubloon polynomial triangle, Ram. J. 23 (2010), 107-126
Dominique Foata and Guo-Niu Han, Doubloons and new q-tangent numbers, Quart. J. Math. 62 (2) (2011) 417-432
S. Forcey, M. Kafashan, M. Maleki and M. Strayer, Recursive bijections for Catalan objects, arXiv preprint arXiv:1212.1188 [math.CO], 2012 and J. Int. Seq. 16 (2013) #13.5.3.
H. G. Forder, Some problems in combinatorics, Math. Gazette, vol. 45, 1961, 199-201. [Annotated scanned copy]
Shishuo Fu and Yaling Wang, Bijective recurrences concerning two Schröder triangles, arXiv:1908.03912 [math.CO], 2019.
J. R. Gaggins, Constructing the Centroid of a Polygon, Math. Gaz., 61 (1988), 211-212.
Mohammad Ganjtabesh, Armin Morabbi and Jean-Marc Steyaert, Enumerating the number of RNA structures
Joël Gay and Vincent Pilaud, The weak order on Weyl posets, arXiv:1804.06572 [math.CO], 2018.
E.-K. Ghang and D. Zeilberger, Zeroless Arithmetic: Representing Integers ONLY using ONE, arXiv preprint arXiv:1303.0885 [math.CO], 2013.
A. Ghasemi, K. Sreenivas and L. K. Taylor, Numerical Stability and Catalan Numbers, arXiv preprint arXiv:1309.4820 [math.NA], 2013.
Étienne Ghys, A Singular Mathematical Promenade, arXiv:1612.06373, 2016.
Juan B. Gil and Michael D. Weiner, On pattern-avoiding Fishburn permutations, arXiv:1812.01682 [math.CO], 2018.
S. Gilliand, C. Johnson, S. Rush, D. Wood, The sock matching problem, Involve, a Journal of Mathematics, Vol. 7 (2014), No. 5, 691-697.
Samuele Giraudo, Pluriassociative algebras II: The polydendriform operad and related operads, arXiv:1603.01394 [math.CO], 2016.
Samuele Giraudo, Tree series and pattern avoidance in syntax trees, arXiv:1903.00677 [math.CO], 2019.
Lisa R. Goldberg, Catalan numbers and branched coverings by the Riemann sphere, Adv. Math. 85 (1991), No. 2, 129-144.
S. Goldstein, J. L. Lebowitz and E. R. Speer, The Discrete-Time Facilitated Totally Asymmetric Simple Exclusion Process, arXiv:2003.04995 [math-ph], 2020.
K. Gorska and K. A. Penson, Multidimensional Catalan and related numbers as Hausdorff moments, arXiv preprint arXiv:1304.6008 [math.CO], 2013.
H. W. Gould, Proof and generalization of a Catalan number formula of Larcombe, Congr. Numer. 165 (2003) p 33-38.
Alain Goupil and Gilles Schaeffer, Factoring N-Cycles and Counting Maps of Given Genus, Europ. J. Combinatorics (1998) 19 819-834.
B. Gourevitch, L'univers de Pi (click Mathematiciens, Gosper)
D. Gouyou-Beauchamps, Chemins sous-diagonaux et tableau de Young, pp. 112-125 of "Combinatoire Enumerative (Montreal 1985)", Lect. Notes Math. 1234, Springer, 1986. (Annotated scanned copy)
Taras Goy and Mark Shattuck, Determinant formulas of some Toeplitz-Hessenberg matrices with Catalan entries, Proceedings of the Indian Academy of Science - Mathematical Sciences, Vol. 129 (2019), Article 46.
Curtis Greene and Brady Haran, Shapes and Hook Numbers (extra footage), Numberphile video (2016)
Catherine Greenhill, Bernard Mans, and Ali Pourmiri, Balanced Allocation on Dynamic Hypergraphs, arXiv:2006.07588 [cs.DS], 2020.
H. G. Grundman and E. A. Teeple, Sequences of Generalized Happy Numbers with Small Bases, Journal of Integer Sequences, Vol. 10 (2007), Article 07.1.8.
R. K. Guy, Dissecting a polygon into triangles, Research Paper #9, Math. Dept., Univ. Calgary, 1967. [Annotated scanned copy]
R. K. Guy, Catwalks, Sandsteps and Pascal Pyramids, J. Integer Seqs., Vol. 3 (2000), #00.1.6.
R. K. Guy and J. L. Selfridge, The nesting and roosting habits of the laddered parenthesis (annotated cached copy)
Mark Haiman, with an Appendix by Ezra Miller, Commutative algebra of n points in the plane, Trends Commut. Algebra, MSRI Publ 51 (2004): 153-180. [See Theorem 1.2]
Guo-Niu Han, Enumeration of Standard Puzzles [Cached copy]
Brady Haran and Sergei Tabachnikov, Frieze Patterns, Numberphile video (2019); more footage
F. Harary & R. W. Robinson, The number of achiral trees, Jnl. Reine Angewandte Mathematik 278 (1975), 322-335. (Annotated scanned copy)
Elizabeth Hartung, Hung Phuc Hoang, Torsten Mütze and Aaron Williams, Combinatorial generation via permutation languages. I. Fundamentals, arXiv:1906.06069 [cs.DM], 2019.
Aoife Hennessy, A Study of Riordan Arrays with Applications to Continued Fractions, Orthogonal Polynomials and Lattice Paths, Ph. D. Thesis, Waterford Institute of Technology, Oct. 2011
A. M. Hinz, S. Klavžar, U. Milutinović and C. Petr, The Tower of Hanoi - Myths and Maths, Birkhäuser 2013. See page 259. Book's website
V. E. Hoggatt, Jr. and M. Bicknell, Catalan and related sequences arising from inverses of Pascal's triangle matrices, Fib. Quart., 14 (1976), 395-405.
V. E. Hoggatt, Jr. and Paul S. Bruckman, The H-convolution transform, Fibonacci Quart., Vol. 13(4), 1975, p. 357.
C. Homberger, Patterns in Permutations and Involutions: A Structural and Enumerative Approach, arXiv preprint arXiv:1410.2657 [math.CO], 2014.
W. Hürlimann (2009). Generalizing Benford's law using power laws: application to integer sequences. International Journal of Mathematics and Mathematical Sciences, Article ID 970284.
Hsien-Kuei Hwang, Mihyun Kang and Guan-Huei Duh, Asymptotic Expansions for Sub-Critical Lagrangean Forms, LIPIcs Proceedings of Analysis of Algorithms (2018), Vol. 110, Article 29.
Anders Hyllengren, Four integer sequences, Oct 04 1985. Observes essentially that A000984 and A002426 are inverse binomial transforms of each other, as are A000108 and A001006.
Milan Janjić, On Restricted Ternary Words and Insets, arXiv:1905.04465 [math.CO], 2019.
A. Joseph and P. Lamprou, A new interpretation of Catalan numbers, arXiv preprint arXiv:1512.00406 [math.CO], 2015.
R. Kahkeshani, A Generalization of the Catalan Numbers, J. Int. Seq. 16 (2013) #13.6.8
Manuel Kauers and Doron Zeilberger, Counting Standard Young Tableaux With Restricted Runs, arXiv:2006.10205 [math.CO], 2020.
Clark Kimberling, Matrix Transformations of Integer Sequences, J. Integer Seqs., Vol. 6, 2003.
Martin Klazar and Richard Horský, Are the Catalan Numbers a Linear Recurrence Sequence?, arXiv:2107.10717 [math.CO], 2021. Published in American Mathematical Monthly, 129:2, 166-171, DOI:10.1080/00029890.2022.2005392.
D. E. Knuth, Convolution polynomials, The Mathematica J., 2 (1992), 67-78.
M. Konvalinka and S. Wagner, The shape of random tanglegrams, arXiv preprint arXiv:1512.01168 [cond-mat.mes-hall], 2015.
G. Kreweras, Sur les éventails de segments, Cahiers du Bureau Universitaire de Recherche Opérationnelle, Institut de Statistique, Université de Paris, #15 (1970), 3-41. [Annotated scanned copy]
G. Kreweras, Sur les partitions non croisées d'un cycle, (in French) Discrete Math. 1 (1972), no. 4, 333-350. MR0309747 (46 #8852)
C. Krishnamachary and M. Bheemasena Rao, Determinants whose elements are Eulerian, prepared Bernoullian and other numbers, J. Indian Math. Soc., 14 (1922), 55-62, 122-138 and 143-146. [Annotated scanned copy]
Nate Kube and Frank Ruskey, Sequences That Satisfy a(n-a(n))=0, Journal of Integer Sequences, Vol. 8 (2005), Article 05.5.5.
Shrinu Kushagra, Shai Ben-David and Ihab Ilyas, Semi-supervised clustering for de-duplication, arXiv:1810.04361 [cs.LG], 2018.
Marie-Louise Lackner and M Wallner, An invitation to analytic combinatorics and lattice path counting; Preprint, Dec 2015.
Wolfdieter Lang, On generalizations of Stirling number triangles, J. Integer Seqs., Vol. 3 (2000), #00.2.4.
Peter J. Larcombe, Daniel R. French, On the "Other" Catalan Numbers: A Historical Formulation Re-Examined, Preprint 2000-2016.
J. W. Layman, The Hankel Transform and Some of its Properties, J. Integer Sequences, 4 (2001), #01.1.5.
Pierre Lescanne, An exercise on streams: convergence acceleration, arXiv preprint arXiv:1312.4917 [cs.NA], 2013.
Hsueh-Yung Lin, The odd Catalan numbers modulo 2^k, arXiv:1012.1756 [math.NT], 2010-2011.
Elżbieta Liszewska and Wojciech Młotkowski, Some relatives of the Catalan sequence, arXiv:1907.10725 [math.CO], 2019.
J.-L. Loday and B. Vallette, Algebraic Operads, version 0.999, 2012.
R. P. Loh, A. G. Shannon, A. F. Horadam, Divisibility Criteria and Sequence Generators Associated with Fermat Coefficients, Preprint, 1980.
Colin L. Mallows and Lou Shapiro, Balls on the Lawn, J. Integer Sequences, Vol. 2, 1999, #5.
C. Mallows and R. J. Vanderbei, Which Young Tableaux Can Represent an Outer Sum?, J. Int. Seq. 18 (2015) 15.9.1.
K Manes, A Sapounakis, I Tasoulas, P Tsikouras, Equivalence classes of ballot paths modulo strings of length 2 and 3, arXiv preprint arXiv:1510.01952 [math.CO], 2015.
Toufik Mansour, Counting Peaks at Height k in a Dyck Path, Journal of Integer Sequences, Vol. 5 (2002), Article 02.1.1
Toufik Mansour, Statistics on Dyck Paths, Journal of Integer Sequences, Vol. 9 (2006), Article 06.1.5.
Toufik Mansour and Mark Shattuck, Counting Dyck Paths According to the Maximum Distance Between Peaks and Valleys, Journal of Integer Sequences, Vol. 15 (2012), #12.1.1.
Toufik Mansour and Yidong Sun, Identities involving Narayana polynomials and Catalan numbers (2008), arXiv:0805.1274 [math.CO]; Discrete Mathematics, Volume 309, Issue 12, Jun 28 2009, Pages 4079-4088
R. J. Marsh and P. P. Martin, Pascal arrays: counting Catalan sets, arXiv:math/0612572 [math.CO], 2006.
MathOverflow, Geometric / physical / probabilistic interpretations of Riemann zeta(n>1)?, answer by Tom Copeland posted in Aug 2021.
Peter McCalla and Asamoah Nkwanta, Catalan and Motzkin Integral Representations, arXiv:1901.07092 [math.NT], 2019.
Jon McCammond, Noncrossing partitions in surprising locations, arXiv:math/0601687 [math.CO], 2006.
D. Merlini, R. Sprugnoli and M. C. Verri, Waiting patterns for a printerDiscrete Applied Mathematics, 144 (2004), 359-373; FUN with algorithm'01, Isola d'Elba, 2001.
Ângela Mestre and José Agapito, A Family of Riordan Group Automorphisms, J. Int. Seq., Vol. 22 (2019), Article 19.8.5.
Marni Mishna and Lily Yen, Set partitions with no k-nesting, arXiv:1106.5036 [math.CO], 2011.
S. Mizera, Combinatorics and Topology of Kawai-Lewellen-Tye Relations, arXiv:1706.08527 [hep-th], 2017.
T. Motzkin, The hypersurface cross ratio, Bull. Amer. Math. Soc., 51 (1945), 976-984.
Torsten Mütze and Franziska Weber, Construction of 2-factors in the middle layer of the discrete cube, arXiv preprint arXiv:1111.2413 [math.CO], 2011.
Liviu I. Nicolaescu, Counting Morse functions on the 2-sphere, arXiv:math/0512496 [math.GT], 2005-2006.
J.-C. Novelli and J.-Y. Thibon, Free quasi-symmetric functions of arbitrary level, arXiv:math/0405597 [math.CO], 2004.
R. J. Nowakowski, G. Renault, E. Lamoureux, S. Mellon and T. Miller, The Game of timber!, 2013.
C. D. Olds (Proposer) and H. W. Becker (Discussion), Problem 4277, Amer. Math. Monthly 56 (1949), 697-699. [Annotated scanned copy]
Igor Pak, History of Catalan numbers, arXiv:1408.5711 [math.HO], 2014.
Hao Pan and Zhi-Wei Sun, A combinatorial identity with application to Catalan numbers, arXiv:math/0509648 [math.CO], 2005-2006.
A. Panayotopoulos and P. Tsikouras, Meanders and Motzkin Words, J. Integer Seqs., Vol. 7, 2004.
A. Panholzer and H. Prodinger, Bijections for ternary trees and non-crossing trees, Discrete Math., 250 (2002), 181-195 (see Eq. 4).
A. Papoulis, A new method of inversion of the Laplace transform, Quart. Appl. Math 14 (1957), 405-414. [Annotated scan of selected pages]
Robert Parviainen, Lattice Path Enumeration of Permutations with k Occurrences of the Pattern 2-13, Journal of Integer Sequences, Vol. 9 (2006), Article 06.3.2.
Ludovic Patey, Ramsey-like theorems and moduli of computation, arXiv:1901.04388 [math.LO], 2019.
P. Peart and W.-J. Woan, Generating Functions via Hankel and Stieltjes Matrices, J. Integer Seqs., Vol. 3 (2000), #00.2.1.
P. Peart and W.-J. Woan, Dyck Paths With No Peaks at Height k, J. Integer Sequences, 4 (2001), #01.1.3.
Robin Pemantle and Mark C. Wilson, Twenty Combinatorial Examples of Asymptotics Derived from Multivariate Generating Functions, SIAM Rev., 50 (2) (2008), 199-272.
K. A. Penson and J.-M. Sixdeniers, Integral Representations of Catalan and Related Numbers, J. Integer Sequences, 4 (2001), #01.2.5.
Karol A. Penson and Karol Zyczkowski, Product of Ginibre matrices : Fuss-Catalan and Raney distribution, arXiv version; Phys. Rev E. vol. 83, 061118 (2011).
T. K. Petersen and Bridget Eileen Tenner, The depth of a permutation, arXiv:1202.4765 [math.CO], 2012-2014.
Ville H. Pettersson, Enumerating Hamiltonian Cycles, The Electronic Journal of Combinatorics, Volume 21, Issue 4, 2014.
Vincent Pilaud, Brick polytopes, lattice quotients, and Hopf algebras, arXiv preprint arXiv:1505.07665 [math.CO], 2015.
Vincent Pilaud, Pebble trees, arXiv:2205.06686 [math.CO], 2022.
Maxim V. Polyakov, Kirill M. Semenov-Tian-Shansky, Alexander O. Smirnov and Alexey A. Vladimirov, Quasi-Renormalizable Quantum Field Theories, arXiv:1811.08449 [hep-th], 2018.
Alexander Postnikov, Permutohedra, associahedra, and beyond, 2005, arXiv:math/0507163 [math.CO], 2005.
J.-B. Priez and A. Virmaux, Non-commutative Frobenius characteristic of generalized parking functions: Application to enumeration, arXiv preprint arXiv:1411.4161 [math.CO], 2014-2015.
L. Pudwell and A. Baxter, Ascent sequences avoiding pairs of patterns, 2014.
Alon Regev, Enumerating Triangulations by Parallel Diagonals, Journal of Integer Sequences, Vol. 15 (2012), #12.8.5; arXiv preprint arXiv:1208.3915, 2012.
Alon Regev, Amitai Regev, and Doron Zeilberger, Identities in character tables of S_n, arXiv preprint arXiv:1507.03499 [math.CO], 2015.
Amitai Regev, Nathaniel Shar, and Doron Zeilberger, A Very Short (Bijective!) Proof of Touchard's Catalan Identity, 2015.
Amitai Regev, Nathaniel Shar, and Doron Zeilberger, A Very Short (Bijective!) Proof of Touchard's Catalan Identity, [Local copy, pdf file only, no active links]
C. M. Ringel, The Catalan combinatorics of the hereditary artin algebras, arXiv preprint arXiv:1502.06553 [math.RT], 2015.
J. Riordan, The distribution of crossings of chords joining pairs of 2n points on a circle, Math. Comp., 29 (1975), 215-222. [Annotated scanned copy]
N. A. Rosenberg, Counting coalescent histories, J. Comput Biol., 14 (2007), 360-377.
E. Rowland and R. Yassawi, Automatic congruences for diagonals of rational functions, arXiv preprint arXiv:1310.8635 [math.NT], 2013-2014.
E. Rowland and D. Zeilberger, A Case Study in Meta-AUTOMATION: AUTOMATIC Generation of Congruence AUTOMATA For Combinatorial Sequences, arXiv preprint arXiv:1311.4776 [math.CO], 2013.
Albert Sade, Sur les Chevauchements des Permutations, published by the author, Marseille, 1949. [Annotated scanned copy]
A. Sapounakis, I. Tasoulas and P. Tsikouras, On the Dominance Partial Ordering of Dyck Paths, Journal of Integer Sequences, Vol. 9 (2006), Article 06.2.5.
A. Sapounakis and P. Tsikouras, On k-colored Motzkin words, Journal of Integer Sequences, Vol. 7 (2004), Article 04.2.5.
E. Schröder, Vier combinatorische Probleme, Z. f. Math. Phys., 15 (1870), 361-376. [Annotated scanned copy]
A. Schuetz and G. Whieldon, Polygonal Dissections and Reversions of Series, arXiv preprint arXiv:1401.7194 [math.CO], 2014.
J. A. von Segner, Enumeratio modorum, quibus figurae planae rectilineae per diagonales dividuntur in triangula, Novi Comm. Acad. Scient. Imper. Petropolitanae, 7 (1758/1759), 203-209.
Sarah Shader, Weighted Catalan Numbers and Their Divisibility Properties, Research Science Institute, MIT, 2014.
L. W. Shapiro, A Catalan triangle, Discrete Math., 14, 83-90, 1976.
L. W. Shapiro, A Catalan triangle, Discrete Math. 14 (1976), no. 1, 83-90. [Annotated scanned copy]
D. M. Silberger, Occurrences of the integer (2n-2)!/n!(n-1)!, Roczniki Polskiego Towarzystwa Math. 13 (1969): 91-96. [Annotated scanned copy]
N. J. A. Sloane, "A Handbook of Integer Sequences" Fifty Years Later, arXiv:2301.03149 [math.NT], 2023, p. 7.
N. Solomon and S. Solomon, A natural extension of Catalan Numbers, JIS 11 (2008) 08.3.5
Frank Sottile, The Schubert Calculus of Lines (a section of Enumerative Real Algebraic Geometry)
Michael Z. Spivey and Laura L. Steil, The k-Binomial Transforms and the Hankel Transform, Journal of Integer Sequences, Vol. 9 (2006), Article 06.1.1.
R. P. Stanley, Hipparchus, Plutarch, Schröder and Hough, Am. Math. Monthly, Vol. 104, No. 4, p. 344, 1997.
R. P. Stanley, Catalan Addendum
R. P. Stanley, Interpretations of Catalan Numbers (Notes) [Annotated scanned copy]
P. J. Stockmeyer, The charm bracelet problem and its applications, pp. 339-349 of Graphs and Combinatorics (Washington, Jun 1973), Ed. by R. A. Bari and F. Harary. Lect. Notes Math., Vol. 406. Springer-Verlag, 1974. [Scanned annotated and corrected copy]
T. Stojadinovic, The Catalan numbers, Preprint 2015.
C. Stump, On a New Collection of Words in the Catalan Family, J. Int. Seq. 17 (2014) # 14.7.1
Zhi-Wei Sun and Roberto Tauraso, On some new congruences for binomial coefficients, arXiv:0709.1665 [math.NT], 2007-2011.
V. S. Sunder, Catalan numbers
P. Tarau, A Generic Numbering System based on Catalan Families of Combinatorial Objects, arXiv preprint arXiv:1406.1796 [cs.MS], 2014.
I. Tasoulas, K. Manes, A. Sapounakis and P. Tsikouras, Chains with Small Intervals in the Lattice of Binary Paths, arXiv:1911.10883 [math.CO], 2019.
B. E. Tenner, Interval structures in the Bruhat and weak orders, arXiv:2001.05011 [math.CO], 2020.
Thotsaporn "Aek" Thanatipanonda and Doron Zeilberger, A Multi-Computational Exploration of Some Games of Pure Chance, arXiv:1909.11546 [math.CO], 2019.
I. Todorov, Studying Quantum Field Theory, arXiv:1311.7258 [math-ph], 2013.
Michael Torpey, Semigroup congruences: computational techniques and theoretical applications, Ph.D. Thesis, University of St. Andrews (Scotland, 2019).
J.-D. Urbina, J. Kuipers, Q. Hummel and K. Richter, Multiparticle correlations in complex scattering and the mesoscopic Boson Sampling problem, arXiv preprint arXiv:1409.1558 [quant-ph], 2014.
A. Vieru, Agoh's conjecture: its proof, its generalizations, its analogues, arXiv:1107.2938 [math.NT], 2011.
Gérard Villemin, Nombres De Catalan (French)
D. W. Walkup, The number of plane trees, Mathematika, vol. 19, No. 2 (1972), 200-204.
Wenxi Wang, Muhammad Usman, Alyas Almaawi, Kaiyuan Wang, Kuldeep S. Meel and Sarfraz Khurshid, A Study of Symmetry Breaking Predicates and Model Counting, National University of Singapore (2020).
Eric Weisstein's World of Mathematics, Binary Bracketing.
Eric Weisstein's World of Mathematics, Binary Tree.
Eric Weisstein's World of Mathematics, Catalan Number.
Eric Weisstein's World of Mathematics, Dyck Path.
Eric Weisstein's World of Mathematics, Nonassociative Product.
Eric Weisstein's World of Mathematics, Staircase Walk.
Wikipedia, Catalan number
J. Winter, M. M. Bonsangue and J. J. M. M. Rutten, Context-free coalgebras, 2013.
Roman Witula, Damian Slota and Edyta Hetmaniok, Bridges between different known integer sequences, Annales Mathematicae et Informaticae, 41 (2013) pp. 255-263.
W.-J. Woan, Hankel Matrices and Lattice Paths, J. Integer Sequences, 4 (2001), #01.1.2.
Wen-jin Woan, A Recursive Relation for Weighted Motzkin Sequences Journal of Integer Sequences, Vol. 8 (2005), Article 05.1.6.
Wen-jin Woan, Animals and 2-Motzkin Paths, Journal of Integer Sequences, Vol. 8 (2005), Article 05.5.6.
Wen-jin Woan, A Relation Between Restricted and Unrestricted Weighted Motzkin Paths, Journal of Integer Sequences, Vol. 9 (2006), Article 06.1.7.
Chunyan Yan and Zhicong Lin, Inversion sequences avoiding pairs of patterns, arXiv:1912.03674 [math.CO], 2019.
F. Yano and H. Yoshida, Some set partition statistics in non-crossing partitions and generating functions, Discr. Math., 307 (2007), 3147-3160.
Yan X Zhang, Four Variations on Graded Posets, arXiv preprint arXiv:1508.00318 [math.CO], 2015.
FORMULA
a(n) = binomial(2*n, n)/(n+1) = (2*n)!/(n!*(n+1)!) = A000984(n)/(n+1).
Recurrence: a(n) = 2*(2*n-1)*a(n-1)/(n+1) with a(0) = 1.
Recurrence: a(n) = Sum_{k=0..n-1} a(k)a(n-1-k).
G.f.: A(x) = (1 - sqrt(1 - 4*x)) / (2*x), and satisfies A(x) = 1 + x*A(x)^2.
a(n) = Product_{k=2..n} (1 + n/k).
a(n+1) = Sum_{i} binomial(n, 2*i)*2^(n-2*i)*a(i). - Touchard
It is known that a(n) is odd if and only if n=2^k-1, k=0, 1, 2, 3, ... - Emeric Deutsch, Aug 04 2002, corrected by M. F. Hasler, Nov 08 2015
Using the Stirling approximation in A000142 we get the asymptotic expansion a(n) ~ 4^n / (sqrt(Pi * n) * (n + 1)). - Dan Fux (dan.fux(AT)OpenGaia.com or danfux(AT)OpenGaia.com), Apr 13 2001
Integral representation: a(n) = (1/(2*Pi))*Integral_{x=0..4} x^n*sqrt((4-x)/x). - Karol A. Penson, Apr 12 2001
E.g.f.: exp(2*x)*(I_0(2*x)-I_1(2*x)), where I_n is Bessel function. - Karol A. Penson, Oct 07 2001
a(n) = polygorial(n, 6)/polygorial(n, 3). - Daniel Dockery (peritus(AT)gmail.com), Jun 24 2003
G.f. A(x) satisfies ((A(x) + A(-x)) / 2)^2 = A(4*x^2). - Michael Somos, Jun 27, 2003
G.f. A(x) satisfies Sum_{k>=1} k(A(x)-1)^k = Sum_{n>=1} 4^{n-1}*x^n. - Shapiro, Woan, Getu
a(n+m) = Sum_{k} A039599(n, k)*A039599(m, k). - Philippe Deléham, Dec 22 2003
a(n+1) = (1/(n+1))*Sum_{k=0..n} a(n-k)*binomial(2k+1, k+1). - Philippe Deléham, Jan 24 2004
a(n) = Sum_{k>=0} A008313(n, k)^2. - Philippe Deléham, Feb 14 2004
a(m+n+1) = Sum_{k>=0} A039598(m, k)*A039598(n, k). - Philippe Deléham, Feb 15 2004
a(n) = Sum_{k=0..n} (-1)^k*2^(n-k)*binomial(n, k)*binomial(k, floor(k/2)). - Paul Barry, Jan 27 2005
Sum_{n>=0} 1/a(n) = 2 + 4*Pi/3^(5/2) = F(1,2;1/2;1/4) = A268813 = 2.806133050770763... (see L'Univers de Pi link). - Gerald McGarvey and Benoit Cloitre, Feb 13 2005
a(n) = Sum_{k=0..floor(n/2)} ((n-2*k+1)*binomial(n, n-k)/(n-k+1))^2, which is equivalent to: a(n) = Sum_{k=0..n} A053121(n, k)^2, for n >= 0. - Paul D. Hanna, Apr 23 2005
a((m+n)/2) = Sum_{k>=0} A053121(m, k)*A053121(n, k) if m+n is even. - Philippe Deléham, May 26 2005
E.g.f. Sum_{n>=0} a(n) * x^(2*n) / (2*n)! = BesselI(1, 2*x) / x. - Michael Somos, Jun 22 2005
Given g.f. A(x), then B(x) = x * A(x^3) satisfies 0 = f(x, B(X)) where f(u, v) = u - v + (u*v)^2 or B(x) = x + (x * B(x))^2 which implies B(-B(x)) = -x and also (1 + B^3) / B^2 = (1 - x^3) / x^2. - Michael Somos, Jun 27 2005
a(n) = a(n-1)*(4-6/(n+1)). a(n) = 2a(n-1)*(8a(n-2)+a(n-1))/(10a(n-2)-a(n-1)). - Franklin T. Adams-Watters, Feb 08 2006
Sum_{k>=1} a(k)/4^k = 1. - Franklin T. Adams-Watters, Jun 28 2006
a(n) = A047996(2*n+1, n). - Philippe Deléham, Jul 25 2006
Binomial transform of A005043. - Philippe Deléham, Oct 20 2006
a(n) = Sum_{k=0..n} (-1)^k*A116395(n,k). - Philippe Deléham, Nov 07 2006
a(n) = (1/(s-n))*Sum_{k=0..n} (-1)^k (k+s-n)*binomial(s-n,k) * binomial(s+n-k,s) with s a nonnegative free integer [H. W. Gould].
a(k) = Sum_{i=1..k} |A008276(i,k)| * (k-1)^(k-i) / k!. - André F. Labossière, May 29 2007
a(n) = Sum_{k=0..n} A129818(n,k) * A007852(k+1). - Philippe Deléham, Jun 20 2007
a(n) = Sum_{k=0..n} A109466(n,k) * A127632(k). - Philippe Deléham, Jun 20 2007
Row sums of triangle A124926. - Gary W. Adamson, Oct 22 2007
Limit_{n->oo} (1 + Sum_{k=0..n} a(k)/A004171(k)) = 4/Pi. - Reinhard Zumkeller, Aug 26 2008
a(n) = Sum_{k=0..n} A120730(n,k)^2 and a(k+1) = Sum_{n>=k} A120730(n,k). - Philippe Deléham, Oct 18 2008
Given an integer t >= 1 and initial values u = [a_0, a_1, ..., a_{t-1}], we may define an infinite sequence Phi(u) by setting a_n = a_{n-1} + a_0*a_{n-1} + a_1*a_{n-2} + ... + a_{n-2}*a_1 for n >= t. For example, the present sequence is Phi([1]) (also Phi([1,1])). - Gary W. Adamson, Oct 27 2008
a(n) = Sum_{l_1=0..n+1} Sum_{l_2=0..n}...Sum_{l_i=0..n-i}...Sum_{l_n=0..1} delta(l_1,l_2,...,l_i,...,l_n) where delta(l_1,l_2,...,l_i,...,l_n) = 0 if any l_i < l_(i+1) and l_(i+1) <> 0 for i=1..n-1 and delta(l_1,l_2,...,l_i,...,l_n) = 1 otherwise. - Thomas Wieder, Feb 25 2009
a(n) = A000680(n)/A006472(n+1). - Mark Dols, Jul 14 2010; corrected by M. F. Hasler, Nov 08 2015
Let A(x) be the g.f., then B(x)=x*A(x) satisfies the differential equation B'(x)-2*B'(x)*B(x)-1=0. - Vladimir Kruchinin, Jan 18 2011
Complement of A092459; A010058(a(n)) = 1. - Reinhard Zumkeller, Mar 29 2011
G.f.: 1/(1-x/(1-x/(1-x/(...)))) (continued fraction). - Joerg Arndt, Mar 18 2011
With F(x) = (1-2*x-sqrt(1-4*x))/(2*x) an o.g.f. in x for the Catalan series, G(x) = x/(1+x)^2 is the compositional inverse of F (nulling the n=0 term). - Tom Copeland, Sep 04 2011
With H(x) = 1/(dG(x)/dx) = (1+x)^3 / (1-x), the n-th Catalan number is given by (1/n!)*((H(x)*d/dx)^n)x evaluated at x=0, i.e., F(x) = exp(x*H(u)*d/du)u, evaluated at u = 0. Also, dF(x)/dx = H(F(x)), and H(x) is the o.g.f. for A115291. - Tom Copeland, Sep 04 2011
From Tom Copeland, Sep 30 2011: (Start)
With F(x) = (1-sqrt(1-4*x))/2 an o.g.f. in x for the Catalan series, G(x)= x*(1-x) is the compositional inverse and this relates the Catalan numbers to the row sums of A125181.
With H(x) = 1/(dG(x)/dx) = 1/(1-2x), the n-th Catalan number (offset 1) is given by (1/n!)*((H(x)*d/dx)^n)x evaluated at x=0, i.e., F(x) = exp(x*H(u)*d/du)u, evaluated at u = 0. Also, dF(x)/dx = H(F(x)). (End)
G.f.: (1-sqrt(1-4*x))/(2*x) = G(0) where G(k) = 1 + (4*k+1)*x/(k+1-2*x*(k+1)*(4*k+3)/(2*x*(4*k+3)+(2*k+3)/G(k+1))); (continued fraction). - Sergei N. Gladkovskii, Nov 30 2011
E.g.f.: exp(2*x)*(BesselI(0,2*x) - BesselI(1,2*x)) = G(0) where G(k) = 1 + (4*k+1)*x/((k+1)*(2*k+1)-x*(k+1)*(2*k+1)*(4*k+3)/(x*(4*k+3)+(k+1)*(2*k+3)/G(k+1))); (continued fraction). - Sergei N. Gladkovskii, Nov 30 2011
E.g.f.: Hypergeometric([1/2],[2],4*x) which coincides with the e.g.f. given just above, and also by Karol A. Penson further above. - Wolfdieter Lang, Jan 13 2012
A076050(a(n)) = n + 1 for n > 0. - Reinhard Zumkeller, Feb 17 2012
a(n) = A208355(2*n-1) = A208355(2*n) for n > 0. - Reinhard Zumkeller, Mar 04 2012
a(n+1) = A214292(2*n+1,n) = A214292(2*n+2,n). - Reinhard Zumkeller, Jul 12 2012
G.f.: 1 + 2*x/(U(0)-2*x) where U(k) = k*(4*x+1) + 2*x + 2 - x*(2*k+3)*(2*k+4)/U(k+1); (continued fraction, Euler's 1st kind, 1-step). - Sergei N. Gladkovskii, Sep 20 2012
G.f.: hypergeom([1/2,1],[2],4*x). - Joerg Arndt, Apr 06 2013
Special values of Jacobi polynomials, in Maple notation: a(n) = 4^n*JacobiP(n,1,-1/2-n,-1)/(n+1). - Karol A. Penson, Jul 28 2013
For n > 0: a(n) = sum of row n in triangle A001263. - Reinhard Zumkeller, Oct 10 2013
a(n) = binomial(2n,n-1)/n and a(n) mod n = binomial(2n,n) mod n = A059288(n). - Jonathan Sondow, Dec 14 2013
a(n-1) = Sum_{t1+2*t2+...+n*tn=n} (-1)^(1+t1+t2+...+tn)*multinomial(t1+t2 +...+tn,t1,t2,...,tn)*a(1)^t1*a(2)^t2*...*a(n)^tn. - Mircea Merca, Feb 27 2014
a(n) = Sum_{k=1..n} binomial(n+k-1,n)/n if n > 0. Alexander Adamchuk, Mar 25 2014
a(n) = -2^(2*n+1) * binomial(n-1/2, -3/2). - Peter Luschny, May 06 2014
a(n) = (4*A000984(n) - A000984(n+1))/2. - Stanislav Sykora, Aug 09 2014
a(n) = A246458(n) * A246466(n). - Tom Edgar, Sep 02 2014
a(n) = (2*n)!*[x^(2*n)]hypergeom([],[2],x^2). - Peter Luschny, Jan 31 2015
a(n) = 4^(n-1)*hypergeom([3/2, 1-n], [3], 1). - Peter Luschny, Feb 03 2015
a(2n) = 2*A000150(2n); a(2n+1) = 2*A000150(2n+1) + a(n). - John Bodeen, Jun 24 2015
a(n) = Sum_{t=1..n+1} n^(t-1)*abs(Stirling1(n+1, t)) / Sum_{t=1..n+1} abs(Stirling1(n+1, t)), for n > 0, see (10) in Cereceda link. - Michel Marcus, Oct 06 2015
a(n) ~ 4^(n-2)*(128 + 160/N^2 + 84/N^4 + 715/N^6 - 10180/N^8)/(N^(3/2)*Pi^(1/2)) where N = 4*n+3. - Peter Luschny, Oct 14 2015
a(n) = Sum_{k=1..floor((n+1)/2)} (-1)^(k-1)*binomial(n+1-k,k)*a(n-k) if n > 0; and a(0) = 1. - David Pasino, Jun 29 2016
Sum_{n>=0} (-1)^n/a(n) = 14/25 - 24*arccsch(2)/(25*sqrt(5)) = 14/25 - 24*A002390/(25*sqrt(5)) = 0.353403708337278061333... - Ilya Gutkovskiy, Jun 30 2016
C(n) = (1/n) * Sum_{i+j+k=n-1} C(i)*C(j)*C(k)*(k+1), n >= 1. - Yuchun Ji, Feb 21 2016
C(n) = 1 + Sum_{i+j+k<n-1} C(i)*C(j)*C(k). - Yuchun Ji, Sep 01 2016
a(n) = A001700(n) - A162551(n) = binomial(2*n+1,n+1). - 2*binomial(2*n,n-1). - Taras Goy, Aug 09 2018
G.f.: A(x) = (1 - sqrt(1 - 4*x)) / (2*x) = 2F1(1/2,1;2;4*x). G.f. A(x) satisfies A = 1 + x*A^2. - R. J. Mathar, Nov 17 2018
C(n) = 1 + Sum_{i=0..n-1} A000245(i). - Yuchun Ji, Jan 10 2019
From A.H.M. Smeets, Apr 11 2020: (Start)
(1+sqrt(1+4*x))/2 = 1-Sum_{i >= 0} a(i)*(-x)^(i+1), for any complex x with |x| < 1/4; and sqrt(x+sqrt(x+sqrt(x+...))) = 1-Sum_{i >= 0} a(i)*(-x)^(i+1), for any complex x with |x| < 1/4 and x <> 0. (End)
a(3n+1)*a(5n+4)*a(15n+10) = a(3n+2)*a(5n+2)*a(15n+11). The first case of Catalan product equation of a triple partition of 23n+15. - Yuchun Ji, Sep 27 2020
a(n) = 4^n * (-1)^(n+1) * 3F2[{n + 1,n + 1/2,n}, {3/2,1}, -1], n >= 1. - Sergii Voloshyn, Oct 22 2020
a(n) = 2^(1 + 2 n) * (-1)^(n)/(1 + n) * 3F2[{n, 1/2 + n, 1 + n}, {1/2, 1}, -1], n >= 1. - Sergii Voloshyn, Nov 08 2020
a(n) = (1/Pi)*4^(n+1)*Integral_{x=0..Pi/2} cos(x)^(2*n)*sin(x)^2 dx. - Greg Dresden, May 30 2021
From Peter Bala, Aug 17 2021: (Start)
G.f. A(x) satisfies A(x) = 1/sqrt(1 - 4*x) * A( -x/(1 - 4*x) ) and (A(x) + A(-x))/2 = 1/sqrt(1 - 4*x) * A( -2*x/(1 - 4*x) ); these are the cases k = 0 and k = -1 of the general formula 1/sqrt(1 - 4*x) * A( (k-1)*x/(1 - 4*x) ) = Sum_{n >= 0} ((k^(n+1) - 1)/(k - 1))*Catalan(n)*x^n.
2 - sqrt(1 - 4*x)/A( k*x/(1 - 4*x) ) = 1 + Sum_{n >= 1} (1 + (k + 1)^n) * Catalan(n-1)*x^n. (End)
Sum_{n>=0} a(n)*(-1/4)^n = 2*(sqrt(2)-1) (A163960). - Amiram Eldar, Mar 22 2022
0 = a(n)*(16*a(n+1) - 10*a(n+2)) + a(n+1)*(2*a(n+1) + a(n+2)) for all n>=0. - Michael Somos, Dec 12 2022
G.f.: (offset 1) 1/G(x), with G(x) = 1 - 2*x - x^2/G(x) (Jacobi continued fraction). - Nikolaos Pantelidis, Feb 01 2023
a(n) = K^(2n+1, n, 1) for all n >= 0, where K^(n, s, x) is the Krawtchouk polynomial defined to be Sum_{k=0..s} (-1)^k * binomial(n-x, s-k) * binomial(x, k). - Vladislav Shubin, Aug 17 2023
From Peter Bala, Feb 03 2024: (Start)
The g.f. A(x) satisfies the following functional equations:
A(x) = 1 + x/(1 - 4*x) * A(-x/(1 - 4*x))^2,
A(x^2) = 1/(1 - 2*x) * A(- x/(1 - 2*x))^2 and, for arbitrary k,
1/(1 - k*x) * A(x/(1 - k*x))^2 = 1/(1 - (k+4)*x) * A(-x/(1 - (k+4)*x))^2. (End)
a(n) = A363448(n) + A363449(n). - Julien Rouyer, Jun 28 2024
EXAMPLE
From Joerg Arndt and Greg Stevenson, Jul 11 2011: (Start)
The following products of 3 transpositions lead to a 4-cycle in S_4:
(1,2)*(1,3)*(1,4);
(1,2)*(1,4)*(3,4);
(1,3)*(1,4)*(2,3);
(1,4)*(2,3)*(2,4);
(1,4)*(2,4)*(3,4). (End)
G.f. = 1 + x + 2*x^2 + 5*x^3 + 14*x^4 + 42*x^5 + 132*x^6 + 429*x^7 + ...
For n=3, a(3)=5 since there are exactly 5 binary sequences of length 7 in which the number of ones first exceed the number of zeros at entry 7, namely, 0001111, 0010111, 0011011, 0100111, and 0101011. - Dennis P. Walsh, Apr 11 2012
From Joerg Arndt, Jun 30 2014: (Start)
The a(4) = 14 branching sequences of the (ordered) trees with 4 non-root nodes are (dots denote zeros):
01: [ 1 1 1 1 . ]
02: [ 1 1 2 . . ]
03: [ 1 2 . 1 . ]
04: [ 1 2 1 . . ]
05: [ 1 3 . . . ]
06: [ 2 . 1 1 . ]
07: [ 2 . 2 . . ]
08: [ 2 1 . 1 . ]
09: [ 2 1 1 . . ]
10: [ 2 2 . . . ]
11: [ 3 . . 1 . ]
12: [ 3 . 1 . . ]
13: [ 3 1 . . . ]
14: [ 4 . . . . ]
(End)
MAPLE
A000108 := n->binomial(2*n, n)/(n+1);
G000108 := (1 - sqrt(1 - 4*x)) / (2*x);
spec := [ A, {A=Prod(Z, Sequence(A))}, unlabeled ]: [ seq(combstruct[count](spec, size=n+1), n=0..42) ];
with(combstruct): bin := {B=Union(Z, Prod(B, B))}: seq(count([B, bin, unlabeled], size=n+1), n=0..25); # Zerinvary Lajos, Dec 05 2007
gser := series(G000108, x=0, 42): seq(coeff(gser, x, n), n=0..41); # Zerinvary Lajos, May 21 2008
seq((2*n)!*coeff(series(hypergeom([], [2], x^2), x, 2*n+2), x, 2*n), n=0..30); # Peter Luschny, Jan 31 2015
A000108List := proc(m) local A, P, n; A := [1, 1]; P := [1];
for n from 1 to m - 2 do P := ListTools:-PartialSums([op(P), A[-1]]);
A := [op(A), P[-1]] od; A end: A000108List(31); # Peter Luschny, Mar 24 2022
MATHEMATICA
Table[(2 n)!/n!/(n + 1)!, {n, 0, 20}]
Table[4^n Gamma[n + 1/2]/(Sqrt[Pi] Gamma[n + 2]), {n, 0, 20}] (* Eric W. Weisstein, Oct 31 2024 *)
Table[Hypergeometric2F1[1 - n, -n, 2, 1], {n, 0, 20}] (* Richard L. Ollerton, Sep 13 2006 *)
Table[CatalanNumber @ n, {n, 0, 20}] (* Robert G. Wilson v, Feb 15 2011 *)
CatalanNumber[Range[0, 20]] (* Eric W. Weisstein, Oct 31 2024 *)
CoefficientList[InverseSeries[Series[x/Sum[x^n, {n, 0, 31}], {x, 0, 31}]]/x, x] (* Mats Granvik, Nov 24 2013 *)
CoefficientList[Series[(1 - Sqrt[1 - 4 x])/(2 x), {x, 0, 20}], x] (* Stefano Spezia, Aug 31 2018 *)
With[{n=21}, CoefficientList[Exp[2x] (BesselI[0, 2x]-BesselI[1, 2x])+O[x]^n, x] Range[0, n-1]!] (* Oliver Seipel, Nov 16 2024. after Karol A. Penson *)
PROG
(PARI) a(n)=binomial(2*n, n)/(n+1) \\ M. F. Hasler, Aug 25 2012
(PARI) a(n) = (2*n)! / n! / (n+1)!
(PARI) a(n) = my(A, m); if( n<0, 0, m=1; A = 1 + x + O(x^2); while(m<=n, m*=2; A = sqrt(subst(A, x, 4*x^2)); A += (A - 1) / (2*x*A)); polcoeff(A, n));
(PARI) {a(n) = if( n<1, n==0, polcoeff( serreverse( x / (1 + x)^2 + x * O(x^n)), n))}; /* Michael Somos */
(PARI) (recur(a, b)=if(b<=2, (a==2)+(a==b)+(a!=b)*(1+a/2), (1+a/b)*recur(a, b-1))); a(n)=recur(n, n); \\ R. J. Cano, Nov 22 2012
(PARI) x='x+O('x^40); Vec((1-sqrt(1-4*x))/(2*x)) \\ Altug Alkan, Oct 13 2015
(MuPAD) combinat::dyckWords::count(n) $ n = 0..38 // Zerinvary Lajos, Apr 14 2007
(Magma) C:= func< n | Binomial(2*n, n)/(n+1) >; [ C(n) : n in [0..60]];
(Magma) [Catalan(n): n in [0..40]]; // Vincenzo Librandi, Apr 02 2011
(Haskell)
import Data.List (genericIndex)
a000108 n = genericIndex a000108_list n
a000108_list = 1 : catalan [1] where
catalan cs = c : catalan (c:cs) where
c = sum $ zipWith (*) cs $ reverse cs
-- Reinhard Zumkeller, Nov 12 2011
a000108 = map last $ iterate (scanl1 (+) . (++ [0])) [1]
-- David Spies, Aug 23 2015
(Sage) [catalan_number(i) for i in range(27)] # Zerinvary Lajos, Jun 26 2008
(Sage) # Generalized algorithm of L. Seidel
def A000108_list(n) :
D = [0]*(n+1); D[1] = 1
b = True; h = 1; R = []
for i in range(2*n-1) :
if b :
for k in range(h, 0, -1) : D[k] += D[k-1]
h += 1; R.append(D[1])
else :
for k in range(1, h, 1) : D[k] += D[k+1]
b = not b
return R
A000108_list(31) # Peter Luschny, Jun 02 2012
(Maxima) A000108(n):=binomial(2*n, n)/(n+1)$ makelist(A000108(n), n, 0, 30); /* Martin Ettl, Oct 24 2012 */
(Python)
from gmpy2 import divexact
A000108 = [1, 1]
for n in range(1, 10**3):
A000108.append(divexact(A000108[-1]*(4*n+2), (n+2))) # Chai Wah Wu, Aug 31 2014
(Python)
# Works in Sage also.
A000108 = [1]
for n in range(1000):
A000108.append(A000108[-1]*(4*n+2)//(n+2)) # Günter Rote, Nov 08 2023
(GAP) A000108:=List([0..30], n->Binomial(2*n, n)/(n+1)); # Muniru A Asiru, Feb 17 2018
CROSSREFS
A row of A060854.
See A001003, A001190, A001699, A000081 for other ways to count parentheses.
Enumerates objects encoded by A014486.
A diagonal of any of the essentially equivalent arrays A009766, A030237, A033184, A059365, A099039, A106566, A130020, A047072.
Cf. A051168 (diagonal of the square array described).
Cf. A033552, A176137 (partitions into Catalan numbers).
Cf. A000753, A000736 (Boustrophedon transforms).
Cf. A120303 (largest prime factor of Catalan number).
Cf. A121839 (reciprocal Catalan constant), A268813.
Cf. A038003, A119861, A119908, A120274, A120275 (odd Catalan number).
Cf. A002390 (decimal expansion of natural logarithm of golden ratio).
Coefficients of square root of the g.f. are A001795/A046161.
For a(n) mod 6 see A259667.
For a(n) in base 2 see A264663.
Hankel transforms with first terms omitted: A001477, A006858, A091962, A078920, A123352, A368025.
Cf. A332602 (conjectured production matrix).
Polyominoes: A001683(n+2) (oriented), A000207 (unoriented), A369314 (chiral), A208355(n-1) (achiral), A001764 {4,oo}.
KEYWORD
core,nonn,easy,eigen,nice,changed
STATUS
approved
Number of unlabeled rooted trees with n nodes (or connected functions with a fixed point).
(Formerly M1180 N0454)
+10
691
0, 1, 1, 2, 4, 9, 20, 48, 115, 286, 719, 1842, 4766, 12486, 32973, 87811, 235381, 634847, 1721159, 4688676, 12826228, 35221832, 97055181, 268282855, 743724984, 2067174645, 5759636510, 16083734329, 45007066269, 126186554308, 354426847597, 997171512998
OFFSET
0,4
COMMENTS
Also, number of ways of arranging n-1 nonoverlapping circles: e.g., there are 4 ways to arrange 3 circles, as represented by ((O)), (OO), (O)O, OOO, also see example. (Of course the rules here are different from the usual counting parentheses problems - compare A000108, A001190, A001699.) See Sloane's link for a proof and Vogeler's link for illustration of a(7) as arrangement of 6 circles.
Take a string of n x's and insert n-1 ^'s and n-1 pairs of parentheses in all possible legal ways (cf. A003018). Sequence gives number of distinct functions. The single node tree is "x". Making a node f2 a child of f1 represents f1^f2. Since (f1^f2)^f3 is just f1^(f2*f3) we can think of it as f1 raised to both f2 and f3, that is, f1 with f2 and f3 as children. E.g., for n=4 the distinct functions are ((x^x)^x)^x; (x^(x^x))^x; x^((x^x)^x); x^(x^(x^x)). - W. Edwin Clark and Russ Cox Apr 29, 2003; corrected by Keith Briggs, Nov 14 2005
Also, number of connected multigraphs of order n without cycles except for one loop. - Washington Bomfim, Sep 04 2010
Also, number of planted trees with n+1 nodes.
Also called "Polya trees" by Genitrini (2016). - N. J. A. Sloane, Mar 24 2017
REFERENCES
F. Bergeron, G. Labelle and P. Leroux, Combinatorial Species and Tree-Like Structures, Camb. 1998, p. 279.
N. L. Biggs et al., Graph Theory 1736-1936, Oxford, 1976, pp. 42, 49.
Miklos Bona, editor, Handbook of Enumerative Combinatorics, CRC Press, 2015, pages 305, 998.
A. Cayley, On the analytical forms called trees, with application to the theory of chemical combinations, Reports British Assoc. Advance. Sci. 45 (1875), 257-305 = Math. Papers, Vol. 9, 427-460 (see p. 451).
J. L. Gross and J. Yellen, eds., Handbook of Graph Theory, CRC Press, 2004; p. 526.
F. Harary, Graph Theory. Addison-Wesley, Reading, MA, 1969, p. 232.
F. Harary and E. M. Palmer, Graphical Enumeration, Academic Press, NY, 1973, pp. 54 and 244.
Alexander S. Karpenko, Łukasiewicz Logics and Prime Numbers, Luniver Press, Beckington, 2006, p. 82.
D. E. Knuth, The Art of Computer Programming, Vol. 1: Fundamental Algorithms, 3d Ed. 1997, pp. 386-388.
D. E. Knuth, The Art of Computer Programming, vol. 1, 3rd ed., Fundamental Algorithms, p. 395, ex. 2.
D. E. Knuth, TAOCP, Vol. 4, Section 7.2.1.6.
G. Polya and R. C. Read, Combinatorial Enumeration of Groups, Graphs and Chemical Compounds, Springer-Verlag, 1987, p. 63.
R. C. Read and R. J. Wilson, An Atlas of Graphs, Oxford, 1998. [Comment from Neven Juric: Page 64 incorrectly gives a(21)=35224832.]
J. Riordan, An Introduction to Combinatorial Analysis, Wiley, 1958, p. 138.
N. J. A. Sloane, A Handbook of Integer Sequences, Academic Press, 1973 (includes this sequence).
N. J. A. Sloane and Simon Plouffe, The Encyclopedia of Integer Sequences, Academic Press, 1995 (includes this sequence).
LINKS
Robert G. Wilson v, Table of n, a(n) for n = 0..1000 (first 201 terms from N. J. A. Sloane)
M. J. H. Al-Kaabi, D. Manchon and F. Patras, Monomial bases and pre-Lie structure for free Lie algebras, arXiv:1708.08312 [math.RA], 2017, See p. 5.
Lluís Alemany-Puig and Ramon Ferrer-i-Cancho, Linear-time calculation of the expected sum of edge lengths in random projective linearizations of trees, arXiv:2107.03277 [cs.CL], 2021.
Winfried Auzinger, H Hofstaetter and O Koch, Symbolic Manipulation of Flows of Nonlinear Evolution Equations, with Application in the Analysis of Split-Step Time Integrators, arXiv preprint arXiv:1605.00453 [math.NA], 2016.
A. Cayley, On the analytical forms called trees, Amer. J. Math., 4 (1881), 266-268.
Bartomeu Fiol, Jairo Martínez-Montoya and Alan Rios Fukelman, The planar limit of N=2 superconformal field theories, arXiv:2003.02879 [hep-th], 2020.
P. Flajolet, S. Gerhold and B. Salvy, On the non-holonomic character of logarithms, powers and the n-th prime function, arXiv:math/0501379 [math.CO], 2005.
P. Flajolet and R. Sedgewick, Analytic Combinatorics, 2009; see page 71.
Loïc Foissy, Algebraic structures on typed decorated rooted trees, arXiv:1811.07572 [math.RA], 2018.
A. Genitrini, Full asymptotic expansion for Polya structures, arXiv:1605.00837 [math.CO], May 03 2016, p. 6.
Ira M. Gessel, Good Will Hunting's Problem: Counting Homeomorphically Irreducible Trees, arXiv:2305.03157 [math.CO], 2023.
Bernhard Gittenberger, Emma Yu Jin and Michael Wallner, On the shape of random Pólya structures, arXiv|1707.02144 [math.CO], 2017-2018; Discrete Math., 341 (2018), 896-911.
F. Goebel, On a 1-1-correspondence between rooted trees and natural numbers, J. Combin. Theory, B 29 (1980), 141-143.
F. Goebel and R. P. Nederpelt, The number of numerical outcomes of iterated powers, Amer. Math. Monthly, 80 (1971), 1097-1103.
Mika Göös and Jukka Suomela, Locally checkable proofs in distributed computing Theory Comput. 12, Paper No. 19, 33 p. (2016).
Vsevolod Gubarev, Rota-Baxter operators on a sum of fields, arXiv:1811.08219 [math.RA], 2018.
Ivan Gutman and Yeong-Nan Yeh, Deducing properties of trees from their Matula numbers, Publications de l'Institut Mathématique (Beograd) (N.S.), Vol. 53(67), pp. 17--22 (1993).
R. K. Guy, Letter to N. J. A. Sloane, 1988-04-12 (annotated scanned copy)
R. K. Guy and J. L. Selfridge, The nesting and roosting habits of the laddered parenthesis (annotated cached copy)
R. K. Guy and J. L. Selfridge, The nesting and roosting habits of the laddered parenthesis, Amer. Math. Monthly 80 (8) (1973), 868-876.
F. Harary and G. Prins, The number of homeomorphically irreducible trees, and other species, Acta Math. 101 (1-2) (1959) 141-161, see page 146.
F. Harary and R. W. Robinson, The number of achiral trees, Jnl. Reine Angewandte Mathematik 278 (1975), 322-335. (Annotated scanned copy)
R. Harary and R. W. Robinson, Isomorphic factorizations VIII: bisectable trees, Combinatorica 4 (2) (1984) 169-179, eq. (4.3)
E. Kalinowski and W. Gluza, Evaluation of High Order Terms for the Hubbard Model in the Strong-Coupling Limit, arXiv:1106.4938 [cond-mat.str-el], 2011 (Physical Review B 85, 045105, Jan 2012).
P. Leroux and B. Miloudi, Généralisations de la formule d'Otter, Ann. Sci. Math. Québec, Vol. 16, No. 1, pp. 53-80, 1992. (Annotated scanned copy)
Dominique Manchon, On the mathematics of rooted trees, Université Clermont-Auvergne (France, 2019).
Math Overflow, Discussion
R. J. Mathar, Topologically Distinct Sets of Non-intersecting Circles in the Plane, arXiv:1603.00077 [math.CO], 2016.
R. I. McLachlan, K. Modin, H. Munthe-Kaas and O. Verdier, What are Butcher series, really? The story of rooted trees and numerical methods for evolution equations, arXiv preprint arXiv:1512.00906 [math.NA], 2015.
Igor Pak, Complexity problems in enumerative combinatorics, arXiv:1803.06636 [math.CO], 2018.
E. M. Palmer and A. J. Schwenk, On the number of trees in a random forest, J. Combin. Theory, B 27 (1979), 109-121.
N. Pippenger, Enumeration of equicolorable trees, SIAM J. Discrete Math., 14 (2001), 93-115.
G. Polya, Kombinatorische Anzahlbestimmungen für Gruppen, Graphen und chemische Verbindungen, Acta Mathematica, vol. 68, no. 1, pp. 145-254, (1937).
N. J. A. Sloane, "A Handbook of Integer Sequences" Fifty Years Later, arXiv:2301.03149 [math.NT], 2023, p. 1.
Peter Steinbach, Field Guide to Simple Graphs, Volume 1, Part 17 (For Volumes 1, 2, 3, 4 of this book see A000088, A008406, A000055, A000664, respectively.)
Peter Steinbach, Field Guide to Simple Graphs, Volume 3, Part 10 (For Volumes 1, 2, 3, 4 of this book see A000088, A008406, A000055, A000664, respectively.)
Peter Steinbach, Field Guide to Simple Graphs, Volume 3, Part 12 (For Volumes 1, 2, 3, 4 of this book see A000088, A008406, A000055, A000664, respectively.)
Roger Vogeler, Six Circles, 2015 (illustration for a(7) as the number of arrangements of six circles).
Eric Weisstein's World of Mathematics, Rooted Tree
Eric Weisstein's World of Mathematics, Planted Tree
G. Xiao, Contfrac
FORMULA
G.f. A(x) satisfies A(x) = x*exp(A(x)+A(x^2)/2+A(x^3)/3+A(x^4)/4+...) [Polya]
Also A(x) = Sum_{n>=1} a(n)*x^n = x / Product_{n>=1} (1-x^n)^a(n).
Recurrence: a(n+1) = (1/n) * Sum_{k=1..n} ( Sum_{d|k} d*a(d) ) * a(n-k+1).
Asymptotically c * d^n * n^(-3/2), where c = A187770 = 0.439924... and d = A051491 = 2.955765... [Polya; Knuth, section 7.2.1.6].
Euler transform is sequence itself with offset -1. - Michael Somos, Dec 16 2001
For n > 1, a(n) = A087803(n) - A087803(n-1). - Vladimir Reshetnikov, Nov 06 2015
For n > 1, a(n) = A123467(n-1). - Falk Hüffner, Nov 26 2015
EXAMPLE
G.f. = x + x^2 + 2*x^3 + 4*x^4 + 9*x^5 + 20*x^6 + 48*x^7 + 115*x^8 + ...
From Joerg Arndt, Jun 29 2014: (Start)
The a(6) = 20 trees with 6 nodes have the following level sequences (with level of root = 0) and parenthesis words:
01: [ 0 1 2 3 4 5 ] (((((())))))
02: [ 0 1 2 3 4 4 ] ((((()()))))
03: [ 0 1 2 3 4 3 ] ((((())())))
04: [ 0 1 2 3 4 2 ] ((((()))()))
05: [ 0 1 2 3 4 1 ] ((((())))())
06: [ 0 1 2 3 3 3 ] (((()()())))
07: [ 0 1 2 3 3 2 ] (((()())()))
08: [ 0 1 2 3 3 1 ] (((()()))())
09: [ 0 1 2 3 2 3 ] (((())(())))
10: [ 0 1 2 3 2 2 ] (((())()()))
11: [ 0 1 2 3 2 1 ] (((())())())
12: [ 0 1 2 3 1 2 ] (((()))(()))
13: [ 0 1 2 3 1 1 ] (((()))()())
14: [ 0 1 2 2 2 2 ] ((()()()()))
15: [ 0 1 2 2 2 1 ] ((()()())())
16: [ 0 1 2 2 1 2 ] ((()())(()))
17: [ 0 1 2 2 1 1 ] ((()())()())
18: [ 0 1 2 1 2 1 ] ((())(())())
19: [ 0 1 2 1 1 1 ] ((())()()())
20: [ 0 1 1 1 1 1 ] (()()()()())
(End)
MAPLE
N := 30: a := [1, 1]; for n from 3 to N do x*mul( (1-x^i)^(-a[i]), i=1..n-1); series(%, x, n+1); b := coeff(%, x, n); a := [op(a), b]; od: a; A000081 := proc(n) if n=0 then 1 else a[n]; fi; end; G000081 := series(add(a[i]*x^i, i=1..N), x, N+2); # also used in A000055
spec := [ T, {T=Prod(Z, Set(T))} ]; A000081 := n-> combstruct[count](spec, size=n); [seq(combstruct[count](spec, size=n), n=0..40)];
# a much more efficient method for computing the result with Maple. It uses two procedures:
a := proc(n) local k; a(n) := add(k*a(k)*s(n-1, k), k=1..n-1)/(n-1) end proc:
a(0) := 0: a(1) := 1: s := proc(n, k) local j; s(n, k) := add(a(n+1-j*k), j=1..iquo(n, k)); # Joe Riel (joer(AT)san.rr.com), Jun 23 2008
# even more efficient, uses the Euler transform:
with(numtheory): a:= proc(n) option remember; local d, j; `if`(n<=1, n, (add(add(d*a(d), d=divisors(j)) *a(n-j), j=1..n-1))/ (n-1)) end:
seq(a(n), n=0..50); # Alois P. Heinz, Sep 06 2008
MATHEMATICA
s[ n_, k_ ] := s[ n, k ]=a[ n+1-k ]+If[ n<2k, 0, s[ n-k, k ] ]; a[ 1 ]=1; a[ n_ ] := a[ n ]=Sum[ a[ i ]s[ n-1, i ]i, {i, 1, n-1} ]/(n-1); Table[ a[ i ], {i, 1, 30} ] (* Robert A. Russell *)
a[n_] := a[n] = If[n <= 1, n, Sum[Sum[d*a[d], {d, Divisors[j]}]*a[n-j], {j, 1, n-1}]/(n-1)]; Table[a[n], {n, 0, 30}] (* Jean-François Alcover, Feb 17 2014, after Alois P. Heinz *)
a[n_] := a[n] = If[n <= 1, n, Sum[a[n - j] DivisorSum[j, # a[#] &], {j, n - 1}]/(n - 1)]; Table[a[n], {n, 0, 30}] (* Jan Mangaldan, May 07 2014, after Alois P. Heinz *)
(* first do *) << NumericalDifferentialEquationAnalysis`; (* then *)
ButcherTreeCount[30] (* v8 onward Robert G. Wilson v, Sep 16 2014 *)
a[n:0|1] := n; a[n_] := a[n] = Sum[m a[m] a[n-k*m], {m, n-1}, {k, (n-1)/m}]/(n-1); Table[a[n], {n, 0, 30}] (* Vladimir Reshetnikov, Nov 06 2015 *)
terms = 31; A[_] = 0; Do[A[x_] = x*Exp[Sum[A[x^k]/k, {k, 1, j}]] + O[x]^j // Normal, {j, 1, terms}]; CoefficientList[A[x], x] (* Jean-François Alcover, Jan 11 2018 *)
PROG
(PARI) {a(n) = local(A = x); if( n<1, 0, for( k=1, n-1, A /= (1 - x^k + x * O(x^n))^polcoeff(A, k)); polcoeff(A, n))}; /* Michael Somos, Dec 16 2002 */
(PARI) {a(n) = local(A, A1, an, i); if( n<1, 0, an = Vec(A = A1 = 1 + O(x^n)); for( m=2, n, i=m\2; an[m] = sum( k=1, i, an[k] * an[m-k]) + polcoeff( if( m%2, A *= (A1 - x^i)^-an[i], A), m-1)); an[n])}; /* Michael Somos, Sep 05 2003 */
(PARI) N=66; A=vector(N+1, j, 1);
for (n=1, N, A[n+1] = 1/n * sum(k=1, n, sumdiv(k, d, d*A[d]) * A[n-k+1] ) );
concat([0], A) \\ Joerg Arndt, Apr 17 2014
(Magma) N := 30; P<x> := PowerSeriesRing(Rationals(), N+1); f := func< A | x*&*[Exp(Evaluate(A, x^k)/k) : k in [1..N]]>; G := x; for i in [1..N] do G := f(G); end for; G000081 := G; A000081 := [0] cat Eltseq(G); // Geoff Bailey (geoff(AT)maths.usyd.edu.au), Nov 30 2009
(Maxima)
g(m):= block([si, v], s:0, v:divisors(m), for si in v do (s:s+r(m/si)/si), s);
r(n):=if n=1 then 1 else sum(Co(n-1, k)/k!, k, 1, n-1);
Co(n, k):=if k=1 then g(n) else sum(g(i+1)*Co(n-i-1, k-1), i, 0, n-k);
makelist(r(n), n, 1, 12); /*Vladimir Kruchinin, Jun 15 2012 */
(Haskell)
import Data.List (genericIndex)
a000081 = genericIndex a000081_list
a000081_list = 0 : 1 : f 1 [1, 0] where
f x ys = y : f (x + 1) (y : ys) where
y = sum (zipWith (*) (map h [1..x]) ys) `div` x
h = sum . map (\d -> d * a000081 d) . a027750_row
-- Reinhard Zumkeller, Jun 17 2013
(Sage)
@CachedFunction
def a(n):
if n < 2: return n
return add(add(d*a(d) for d in divisors(j))*a(n-j) for j in (1..n-1))/(n-1)
[a(n) for n in range(31)] # Peter Luschny, Jul 18 2014 after Alois P. Heinz
(Sage) [0]+[RootedTrees(n).cardinality() for n in range(1, 31)] # Freddy Barrera, Apr 07 2019
(Python)
from functools import lru_cache
from sympy import divisors
@lru_cache(maxsize=None)
def divisor_tuple(n): # cached unordered tuple of divisors
return tuple(divisors(n, generator=True))
@lru_cache(maxsize=None)
def A000081(n): return n if n <= 1 else sum(sum(d*A000081(d) for d in divisor_tuple(k))*A000081(n-k) for k in range(1, n))//(n-1) # Chai Wah Wu, Jan 14 2022
CROSSREFS
Cf. A000041 (partitions), A000055 (unrooted trees), A000169, A001858, A005200, A027750, A051491, A051492, A093637, A187770, A199812, A255170, A087803 (partial sums).
Row sums of A144963. - Gary W. Adamson, Sep 27 2008
Cf. A209397 (log(A(x)/x)).
Cf. A000106 (self-convolution).
Column k=1 of A033185 and A034799; column k=0 of A008295.
KEYWORD
nonn,easy,core,nice,eigen
STATUS
approved
Double factorial of odd numbers: a(n) = (2*n-1)!! = 1*3*5*...*(2*n-1).
(Formerly M3002 N1217)
+10
624
1, 1, 3, 15, 105, 945, 10395, 135135, 2027025, 34459425, 654729075, 13749310575, 316234143225, 7905853580625, 213458046676875, 6190283353629375, 191898783962510625, 6332659870762850625, 221643095476699771875, 8200794532637891559375, 319830986772877770815625
OFFSET
0,3
COMMENTS
The solution to Schröder's third problem.
Number of fixed-point-free involutions in symmetric group S_{2n} (cf. A000085).
a(n-2) is the number of full Steiner topologies on n points with n-2 Steiner points. [corrected by Lyle Ramshaw, Jul 20 2022]
a(n) is also the number of perfect matchings in the complete graph K(2n). - Ola Veshta (olaveshta(AT)my-deja.com), Mar 25 2001
Number of ways to choose n disjoint pairs of items from 2*n items. - Ron Zeno (rzeno(AT)hotmail.com), Feb 06 2002
Number of ways to choose n-1 disjoint pairs of items from 2*n-1 items (one item remains unpaired). - Bartosz Zoltak, Oct 16 2012
For n >= 1 a(n) is the number of permutations in the symmetric group S_(2n) whose cycle decomposition is a product of n disjoint transpositions. - Ahmed Fares (ahmedfares(AT)my-deja.com), Apr 21 2001
a(n) is the number of distinct products of n+1 variables with commutative, nonassociative multiplication. - Andrew Walters (awalters3(AT)yahoo.com), Jan 17 2004. For example, a(3)=15 because the product of the four variables w, x, y and z can be constructed in exactly 15 ways, assuming commutativity but not associativity: 1. w(x(yz)) 2. w(y(xz)) 3. w(z(xy)) 4. x(w(yz)) 5. x(y(wz)) 6. x(z(wy)) 7. y(w(xz)) 8. y(x(wz)) 9. y(z(wx)) 10. z(w(xy)) 11. z(x(wy)) 12. z(y(wx)) 13. (wx)(yz) 14. (wy)(xz) 15. (wz)(xy).
a(n) = E(X^(2n)), where X is a standard normal random variable (i.e., X is normal with mean = 0, variance = 1). So for instance a(3) = E(X^6) = 15, etc. See Abramowitz and Stegun or Hoel, Port and Stone. - Jerome Coleman, Apr 06 2004
Second Eulerian transform of 1,1,1,1,1,1,... The second Eulerian transform transforms a sequence s to a sequence t by the formula t(n) = Sum_{k=0..n} E(n,k)s(k), where E(n,k) is a second-order Eulerian number (A008517). - Ross La Haye, Feb 13 2005
Integral representation as n-th moment of a positive function on the positive axis, in Maple notation: a(n) = int(x^n*exp(-x/2)/sqrt(2*Pi*x), x=0..infinity), n=0,1... . - Karol A. Penson, Oct 10 2005
a(n) is the number of binary total partitions of n+1 (each non-singleton block must be partitioned into exactly two blocks) or, equivalently, the number of unordered full binary trees with n+1 labeled leaves (Stanley, ex 5.2.6). - Mitch Harris, Aug 01 2006
a(n) is the Pfaffian of the skew-symmetric 2n X 2n matrix whose (i,j) entry is i for i<j. - David Callan, Sep 25 2006
a(n) is the number of increasing ordered rooted trees on n+1 vertices where "increasing" means the vertices are labeled 0,1,2,...,n so that each path from the root has increasing labels. Increasing unordered rooted trees are counted by the factorial numbers A000142. - David Callan, Oct 26 2006
Number of perfect multi Skolem-type sequences of order n. - Emeric Deutsch, Nov 24 2006
a(n) = total weight of all Dyck n-paths (A000108) when each path is weighted with the product of the heights of the terminal points of its upsteps. For example with n=3, the 5 Dyck 3-paths UUUDDD, UUDUDD, UUDDUD, UDUUDD, UDUDUD have weights 1*2*3=6, 1*2*2=4, 1*2*1=2, 1*1*2=2, 1*1*1=1 respectively and 6+4+2+2+1=15. Counting weights by height of last upstep yields A102625. - David Callan, Dec 29 2006
a(n) is the number of increasing ternary trees on n vertices. Increasing binary trees are counted by ordinary factorials (A000142) and increasing quaternary trees by triple factorials (A007559). - David Callan, Mar 30 2007
From Tom Copeland, Nov 13 2007, clarified in first and extended in second paragraph, Jun 12 2021: (Start)
a(n) has the e.g.f. (1-2x)^(-1/2) = 1 + x + 3*x^2/2! + ..., whose reciprocal is (1-2x)^(1/2) = 1 - x - x^2/2! - 3*x^3/3! - ... = b(0) - b(1)*x - b(2)*x^2/2! - ... with b(0) = 1 and b(n+1) = -a(n) otherwise. By the formalism of A133314, Sum_{k=0..n} binomial(n,k)*b(k)*a(n-k) = 0^n where 0^0 := 1. In this sense, the sequence a(n) is essentially self-inverse. See A132382 for an extension of this result. See A094638 for interpretations.
This sequence aerated has the e.g.f. e^(t^2/2) = 1 + t^2/2! + 3*t^4/4! + ... = c(0) + c(1)*t + c(2)*t^2/2! + ... and the reciprocal e^(-t^2/2); therefore, Sum_{k=0..n} cos(Pi k/2)*binomial(n,k)*c(k)*c(n-k) = 0^n; i.e., the aerated sequence is essentially self-inverse. Consequently, Sum_{k=0..n} (-1)^k*binomial(2n,2k)*a(k)*a(n-k) = 0^n. (End)
From Ross Drewe, Mar 16 2008: (Start)
This is also the number of ways of arranging the elements of n distinct pairs, assuming the order of elements is significant but the pairs are not distinguishable, i.e., arrangements which are the same after permutations of the labels are equivalent.
If this sequence and A000680 are denoted by a(n) and b(n) respectively, then a(n) = b(n)/n! where n! = the number of ways of permuting the pair labels.
For example, there are 90 ways of arranging the elements of 3 pairs [1 1], [2 2], [3 3] when the pairs are distinguishable: A = { [112233], [112323], ..., [332211] }.
By applying the 6 relabeling permutations to A, we can partition A into 90/6 = 15 subsets: B = { {[112233], [113322], [221133], [223311], [331122], [332211]}, {[112323], [113232], [221313], [223131], [331212], [332121]}, ....}
Each subset or equivalence class in B represents a unique pattern of pair relationships. For example, subset B1 above represents {3 disjoint pairs} and subset B2 represents {1 disjoint pair + 2 interleaved pairs}, with the order being significant (contrast A132101). (End)
A139541(n) = a(n) * a(2*n). - Reinhard Zumkeller, Apr 25 2008
a(n+1) = Sum_{j=0..n} A074060(n,j) * 2^j. - Tom Copeland, Sep 01 2008
From Emeric Deutsch, Jun 05 2009: (Start)
a(n) is the number of adjacent transpositions in all fixed-point-free involutions of {1,2,...,2n}. Example: a(2)=3 because in 2143=(12)(34), 3412=(13)(24), and 4321=(14)(23) we have 2 + 0 + 1 adjacent transpositions.
a(n) = Sum_{k>=0} k*A079267(n,k).
(End)
Hankel transform is A137592. - Paul Barry, Sep 18 2009
(1, 3, 15, 105, ...) = INVERT transform of A000698 starting (1, 2, 10, 74, ...). - Gary W. Adamson, Oct 21 2009
a(n) = (-1)^(n+1)*H(2*n,0), where H(n,x) is the probabilists' Hermite polynomial. The generating function for the probabilists' Hermite polynomials is as follows: exp(x*t-t^2/2) = Sum_{i>=0} H(i,x)*t^i/i!. - Leonid Bedratyuk, Oct 31 2009
The Hankel transform of a(n+1) is A168467. - Paul Barry, Dec 04 2009
Partial products of odd numbers. - Juri-Stepan Gerasimov, Oct 17 2010
See A094638 for connections to differential operators. - Tom Copeland, Sep 20 2011
a(n) is the number of subsets of {1,...,n^2} that contain exactly k elements from {1,...,k^2} for k=1,...,n. For example, a(3)=15 since there are 15 subsets of {1,2,...,9} that satisfy the conditions, namely, {1,2,5}, {1,2,6}, {1,2,7}, {1,2,8}, {1,2,9}, {1,3,5}, {1,3,6}, {1,3,7}, {1,3,8}, {1,3,9}, {1,4,5}, {1,4,6}, {1,4,7}, {1,4,8}, and {1,4,9}. - Dennis P. Walsh, Dec 02 2011
a(n) is the leading coefficient of the Bessel polynomial y_n(x) (cf. A001498). - Leonid Bedratyuk, Jun 01 2012
For n>0: a(n) is also the determinant of the symmetric n X n matrix M defined by M(i,j) = min(i,j)^2 for 1 <= i,j <= n. - Enrique Pérez Herrero, Jan 14 2013
a(n) is also the numerator of the mean value from 0 to Pi/2 of sin(x)^(2n). - Jean-François Alcover, Jun 13 2013
a(n) is the size of the Brauer monoid on 2n points (see A227545). - James Mitchell, Jul 28 2013
For n>1: a(n) is the numerator of M(n)/M(1) where the numbers M(i) have the property that M(n+1)/M(n) ~ n-1/2 (for example, large Kendell-Mann numbers, see A000140 or A181609, as n --> infinity). - Mikhail Gaichenkov, Jan 14 2014
a(n) = the number of upper-triangular matrix representations required for the symbolic representation of a first order central moment of the multivariate normal distribution of dimension 2(n-1), i.e., E[X_1*X_2...*X_(2n-2)|mu=0, Sigma]. See vignette for symmoments R package on CRAN and Phillips reference below. - Kem Phillips, Aug 10 2014
For n>1: a(n) is the number of Feynman diagrams of order 2n (number of internal vertices) for the vacuum polarization with one charged loop only, in quantum electrodynamics. - Robert Coquereaux, Sep 15 2014
Aerated with intervening zeros (1,0,1,0,3,...) = a(n) (cf. A123023), the e.g.f. is e^(t^2/2), so this is the base for the Appell sequence A099174 with e.g.f. e^(t^2/2) e^(x*t) = exp(P(.,x),t) = unsigned A066325(x,t), the probabilist's (or normalized) Hermite polynomials. P(n,x) = (a. + x)^n with (a.)^n = a_n and comprise the umbral compositional inverses for A066325(x,t) = exp(UP(.,x),t), i.e., UP(n,P(.,t)) = x^n = P(n,UP(.,t)), where UP(n,t) are the polynomials of A066325 and, e.g., (P(.,t))^n = P(n,t). - Tom Copeland, Nov 15 2014
a(n) = the number of relaxed compacted binary trees of right height at most one of size n. A relaxed compacted binary tree of size n is a directed acyclic graph consisting of a binary tree with n internal nodes, one leaf, and n pointers. It is constructed from a binary tree of size n, where the first leaf in a post-order traversal is kept and all other leaves are replaced by pointers. These links may point to any node that has already been visited by the post-order traversal. The right height is the maximal number of right-edges (or right children) on all paths from the root to any leaf after deleting all pointers. The number of unbounded relaxed compacted binary trees of size n is A082161(n). See the Genitrini et al. link. - Michael Wallner, Jun 20 2017
Also the number of distinct adjacency matrices in the n-ladder rung graph. - Eric W. Weisstein, Jul 22 2017
From Christopher J. Smyth, Jan 26 2018: (Start)
a(n) = the number of essentially different ways of writing a probability distribution taking n+1 values as a sum of products of binary probability distributions. See comment of Mitch Harris above. This is because each such way corresponds to a full binary tree with n+1 leaves, with the leaves labeled by the values. (This comment is due to Niko Brummer.)
Also the number of binary trees with root labeled by an (n+1)-set S, its n+1 leaves by the singleton subsets of S, and other nodes labeled by subsets T of S so that the two daughter nodes of the node labeled by T are labeled by the two parts of a 2-partition of T. This also follows from Mitch Harris' comment above, since the leaf labels determine the labels of the other vertices of the tree.
(End)
a(n) is the n-th moment of the chi-squared distribution with one degree of freedom (equivalent to Coleman's Apr 06 2004 comment). - Bryan R. Gillespie, Mar 07 2021
Let b(n) = 0 for n odd and b(2k) = a(k); i.e., let the sequence b(n) be an aerated version of this entry. After expanding the differential operator (x + D)^n and normal ordering the resulting terms, the integer coefficient of the term x^k D^m is n! b(n-k-m) / [(n-k-m)! k! m!] with 0 <= k,m <= n and (k+m) <= n. E.g., (x+D)^2 = x^2 + 2xD + D^2 + 1 with D = d/dx. The result generalizes to the raising (R) and lowering (L) operators of any Sheffer polynomial sequence by replacing x by R and D by L and follows from the disentangling relation e^{t(L+R)} = e^{t^2/2} e^{tR} e^{tL}. Consequently, these are also the coefficients of the reordered 2^n permutations of the binary symbols L and R under the condition LR = RL + 1. E.g., (L+R)^2 = LL + LR + RL + RR = LL + 2RL + RR + 1. (Cf. A344678.) - Tom Copeland, May 25 2021
From Tom Copeland, Jun 14 2021: (Start)
Lando and Zvonkin present several scenarios in which the double factorials occur in their role of enumerating perfect matchings (pairings) and as the nonzero moments of the Gaussian e^(x^2/2).
Speyer and Sturmfels (p. 6) state that the number of facets of the abstract simplicial complex known as the tropical Grassmannian G'''(2,n), the space of phylogenetic T_n trees (see A134991), or Whitehouse complex is a shifted double factorial.
These are also the unsigned coefficients of the x[2]^m terms in the partition polynomials of A134685 for compositional inversion of e.g.f.s, a refinement of A134991.
a(n)*2^n = A001813(n) and A001813(n)/(n+1)! = A000108(n), the Catalan numbers, the unsigned coefficients of the x[2]^m terms in the partition polynomials A133437 for compositional inversion of o.g.f.s, a refinement of A033282, A126216, and A086810. Then the double factorials inherit a multitude of analytic and combinatoric interpretations from those of the Catalan numbers, associahedra, and the noncrossing partitions of A134264 with the Catalan numbers as unsigned-row sums. (End)
Connections among the Catalan numbers A000108, the odd double factorials, values of the Riemann zeta function and its derivative for integer arguments, and series expansions of the reduced action for the simple harmonic oscillator and the arc length of the spiral of Archimedes are given in the MathOverflow post on the Riemann zeta function. - Tom Copeland, Oct 02 2021
b(n) = a(n) / (n! 2^n) = Sum_{k = 0..n} (-1)^n binomial(n,k) (-1)^k a(k) / (k! 2^k) = (1-b.)^n, umbrally; i.e., the normalized double factorial a(n) is self-inverse under the binomial transform. This can be proved by applying the Euler binomial transformation for o.g.f.s Sum_{n >= 0} (1-b_n)^n x^n = (1/(1-x)) Sum_{n >= 0} b_n (x / (x-1))^n to the o.g.f. (1-x)^{-1/2} = Sum_{n >= 0} b_n x^n. Other proofs are suggested by the discussion in Watson on pages 104-5 of transformations of the Bessel functions of the first kind with b(n) = (-1)^n binomial(-1/2,n) = binomial(n-1/2,n) = (2n)! / (n! 2^n)^2. - Tom Copeland, Dec 10 2022
REFERENCES
M. Abramowitz and I. A. Stegun, eds., Handbook of Mathematical Functions, National Bureau of Standards Applied Math. Series 55, Tenth Printing, 1972, (26.2.28).
Miklos Bona, editor, Handbook of Enumerative Combinatorics, CRC Press, 2015, page 317.
L. Comtet, Advanced Combinatorics, Reidel, 1974, p. 228, #19.
Hoel, Port and Stone, Introduction to Probability Theory, Section 7.3.
F. K. Hwang, D. S. Richards and P. Winter, The Steiner Tree Problem, North-Holland, 1992, see p. 14.
C. Itzykson and J.-B. Zuber, Quantum Field Theory, McGraw-Hill, 1980, pages 466-467.
N. J. A. Sloane, A Handbook of Integer Sequences, Academic Press, 1973 (includes this sequence).
N. J. A. Sloane and Simon Plouffe, The Encyclopedia of Integer Sequences, Academic Press, 1995 (includes this sequence).
R. P. Stanley, Enumerative Combinatorics, Cambridge, Vol. 2, 1999; see Example 5.2.6 and also p. 178.
R. Vein and P. Dale, Determinants and Their Applications in Mathematical Physics, Springer-Verlag, New York, 1999, p. 73.
G. Watson, The Theory of Bessel Functions, Cambridge Univ. Press, 1922.
LINKS
Stefano Spezia, Table of n, a(n) for n = 0..400 (first 102 terms from T. D. Noe)
M. Abramowitz and I. A. Stegun, eds., Handbook of Mathematical Functions, National Bureau of Standards, Applied Math. Series 55, Tenth Printing, 1972 [alternative scanned copy].
José A. Adell and Beáta Bényi, Probabilistic Stirling numbers and applications, Aequat. Math. (2024). See p. 18.
Christian Aebi and Grant Cairns, Generalizations of Wilson's Theorem for Double-, Hyper-, Sub-and Superfactorials, The American Mathematical Monthly 122.5 (2015): 433-443.
D. Arques and J.-F. Beraud, Rooted maps on orientable surfaces, Riccati's equation and continued fractions, Discrete Math., 215 (2000), 1-12.
Fatemeh Bagherzadeh, M. Bremner, and S. Madariaga, Jordan Trialgebras and Post-Jordan Algebras, arXiv preprint arXiv:1611.01214 [math.RA], 2016.
Cyril Banderier, Philippe Marchal, and Michael Wallner, Rectangular Young tableaux with local decreases and the density method for uniform random generation (short version), arXiv:1805.09017 [cs.DM], 2018.
Paul Barry, On a Generalization of the Narayana Triangle, J. Int. Seq. 14 (2011) # 11.4.5.
Paul Barry, On the f-Matrices of Pascal-like Triangles Defined by Riordan Arrays, arXiv:1805.02274 [math.CO], 2018.
Paul Barry and A. Hennessy, The Euler-Seidel Matrix, Hankel Matrices and Moment Sequences, J. Int. Seq. 13 (2010) # 10.8.2.
Natasha Blitvić and Einar Steingrímsson, Permutations, moments, measures, arXiv:2001.00280 [math.CO], 2020.
O. Bodini, M. Dien, X. Fontaine, A. Genitrini, and H. K. Hwang, Increasing Diamonds, in LATIN 2016: 12th Latin American Symposium, Ensenada, Mexico, April 11-15, 2016, Proceedings Pages pp. 207-219 2016 DOI 10.1007/978-3-662-49529-2_16; Lecture Notes in Computer Science Series Volume 9644.
Jonathan Burns, Egor Dolzhenko, Nataša Jonoska, Tilahun Muche and Masahico Saito, Four-Regular Graphs with Rigid Vertices Associated to DNA Recombination, Discrete Applied Mathematics, 161 (2013), 1378-1394.
David Callan, A combinatorial survey of identities for the double factorial, arXiv:0906.1317 [math.CO], 2009.
Peter J. Cameron, Some treelike objects Quart. J. Math. Oxford Ser. 38 (1987), 155-183. MR0891613 (89a:05009). See p. 155.
P. J. Cameron, Sequences realized by oligomorphic permutation groups, J. Integ. Seqs. Vol. 3 (2000), #00.1.5.
P. Codara, O. M. D'Antona, P. Hell, A simple combinatorial interpretation of certain generalized Bell and Stirling numbers, arXiv preprint arXiv:1308.1700 [cs.DM], 2013.
Thierry Dana-Picard, Sequences of Definite Integrals, Factorials and Double Factorials, Journal of Integer Sequences, Vol. 8 (2005), Article 05.4.6.
Filippo Disanto and Thomas Wiehe, Some combinatorial problems on binary rooted trees occurring in population genetics, arXiv preprint arXiv:1112.1295 [math.CO], 2011.
John Engbers, David Galvin, and Clifford Smyth, Restricted Stirling and Lah numbers and their inverses, arXiv:1610.05803 [math.CO], 2016. See p. 5.
J. Felsenstein, The number of evolutionary trees, Systematic Zoology, 27 (1978), 27-33. (Annotated scanned copy)
FindStat - Combinatorial Statistic Finder, Perfect matchings
A. Genitrini, B. Gittenberger, M. Kauers and M. Wallner, Asymptotic Enumeration of Compacted Binary Trees, arXiv:1703.10031 [math.CO], 2017.
Ghislain R. Franssens, On a Number Pyramid Related to the Binomial, Deleham, Eulerian, MacMahon and Stirling number triangles, Journal of Integer Sequences, Vol. 9 (2006), Article 06.4.1.
S. Goodenough and C. Lavault, On subsets of Riordan subgroups and Heisenberg--Weyl algebra, arXiv:1404.1894 [cs.DM], 2014.
S. Goodenough and C. Lavault, Overview on Heisenberg—Weyl Algebra and Subsets of Riordan Subgroups, The Electronic Journal of Combinatorics, 22(4) (2015), #P4.16.
W. S. Gray and M. Thitsa, System Interconnections and Combinatorial Integer Sequences, in: System Theory (SSST), 2013 45th Southeastern Symposium on, Date of Conference: 11-11 Mar 2013.
Paul W. Haggard, On Legendre numbers, International Journal of Mathematics and Mathematical Sciences, vol. 8, Article ID 787189, 5 pages, 1985. See Table 1 p. 408.
Guo-Niu Han, Enumeration of Standard Puzzles, 2011. [Cached copy]
Guo-Niu Han, Enumeration of Standard Puzzles, arXiv:2006.14070 [math.CO], 2020.
Aoife Hennessy, A Study of Riordan Arrays with Applications to Continued Fractions, Orthogonal Polynomials and Lattice Paths, Ph. D. Thesis, Waterford Institute of Technology, Oct. 2011.
J. Jakes-Schauer, D. Anekstein, and P. Wocjan, Carving-width and contraction trees for tensor networks, arXiv:1908.11034 [cs.DM], 2019.
L. B. W. Jolley, Summation of Series, Dover, 1961 p. 48.
M. Kauers and S.-L. Ko, Problem 11545, Amer. Math. Monthly, 118 (2011), p. 84.
A. Khruzin, Enumeration of chord diagrams, arXiv:math/0008209 [math.CO], 2000.
M. Klazar, Twelve countings with rooted plane trees, European Journal of Combinatorics 18 (1997), 195-210; Addendum, 18 (1997), 739-740.
S. Lando and A. Zvonkin, Graphs on surfaces and their applications, Encyclopaedia of Mathematical Sciences, 141, Springer, 2004.
Wolfdieter Lang, On generalizations of Stirling number triangles, J. Integer Seqs., Vol. 3 (2000), #00.2.4.
F. Larrion, M. A. Pizana, and R. Villarroel-Flores, The clique operator on matching and chessboard graphs Discrete Math. 309 (2009), no. 1, 85-93.
E. Lucas, Theorie des nombres (annotated scans of a few selected pages).
Robert J. Marsh and Paul Martin, Tiling bijections between paths and Brauer diagrams, Journal of Algebraic Combinatorics, Vol 33, No 3 (2011), pp. 427-453.
MathOverflow, Geometric / physical / probabilistic interpretations of Riemann zeta(n>1)?, answer by Tom Copeland posted in Aug 2021.
B. E. Meserve, Double Factorials, American Mathematical Monthly, 55 (1948), 425-426.
T. Motzkin, The hypersurface cross ratio, Bull. Amer. Math. Soc., 51 (1945), 976-984.
F. Murtagh, Counting dendrograms: a survey, Discrete Applied Mathematics, 7 (1984), 191-199.
G. Nordh, Perfect Skolem sequences, arXiv:math/0506155 [math.CO], 2005.
J.-C. Novelli and J.-Y. Thibon, Hopf Algebras of m-permutations,(m+1)-ary trees, and m-parking functions, arXiv preprint arXiv:1403.5962 [math.CO], 2014.
R. Ondrejka, Tables of double factorials, Math. Comp., 24 (1970), 231.
L. Pachter and B. Sturmfels, The mathematics of phylogenomics, arXiv:math/0409132 [math.ST], 2004-2005.
R. A. Proctor, Let's Expand Rota's Twelvefold Way for Counting Partitions!, arXiv:math/0606404 [math.CO], 2006-2007.
Helmut Prodinger, Descendants in heap ordered trees or a triumph of computer algebra, The Electronic Journal of Combinatorics, Volume 3, Issue 1 (1996), R29.
S. Ramanujan, Question 541, J. Ind. Math. Soc.
D. F. Robinson, Comparison of labeled trees with valency three, J. Combin. Theory Ser. B, 11 (1971), 105-119.
M. D. Schmidt, Generalized j-Factorial Functions, Polynomials, and Applications, J. Int. Seq. 13 (2010), 10.6.7, (6.27).
E. Schröder, Vier combinatorische Probleme, Z. f. Math. Phys., 15 (1870), 361-376.
E. Schröder, Vier combinatorische Probleme, Z. f. Math. Phys., 15 (1870), 361-376. [Annotated scanned copy]
Y. S. Song, On the combinatorics of rooted binary phylogenetic trees, Annals of Combinatorics, 7, 2003, 365-379. See Lemma 2.1. - N. J. A. Sloane, Aug 22 2014
D. Speyer and B. Sturmfels, The tropical Grassmannian, arXiv:0304218 [math.AG], 2003.
Neriman Tokcan, Jonathan Gryak, Kayvan Najarian, and Harm Derksen, Algebraic Methods for Tensor Data, arXiv:2005.12988 [math.RT], 2020.
Michael Torpey, Semigroup congruences: computational techniques and theoretical applications, Ph.D. Thesis, University of St. Andrews (Scotland, 2019).
Andrew Vince and Miklos Bona, The Number of Ways to Assemble a Graph, arXiv preprint arXiv:1204.3842 [math.CO], 2012.
Eric Weisstein's World of Mathematics, Adjacency Matrix
Eric Weisstein's World of Mathematics, Double Factorial
Eric Weisstein's World of Mathematics, Erf
Eric Weisstein's World of Mathematics, Ladder Rung Graph
Eric Weisstein's World of Mathematics, Normal Distribution Function
Wikipedia, Pfaffian
FORMULA
E.g.f.: 1 / sqrt(1 - 2*x).
D-finite with recurrence: a(n) = a(n-1)*(2*n-1) = (2*n)!/(n!*2^n) = A010050(n)/A000165(n).
a(n) ~ sqrt(2) * 2^n * (n/e)^n.
Rational part of numerator of Gamma(n+1/2): a(n) * sqrt(Pi) / 2^n = Gamma(n+1/2). - Yuriy Brun, Ewa Dominowska (brun(AT)mit.edu), May 12 2001
With interpolated zeros, the sequence has e.g.f. exp(x^2/2). - Paul Barry, Jun 27 2003
The Ramanujan polynomial psi(n+1, n) has value a(n). - Ralf Stephan, Apr 16 2004
a(n) = Sum_{k=0..n} (-2)^(n-k)*A048994(n, k). - Philippe Deléham, Oct 29 2005
Log(1 + x + 3*x^2 + 15*x^3 + 105*x^4 + 945*x^5 + 10395*x^6 + ...) = x + 5/2*x^2 + 37/3*x^3 + 353/4*x^4 + 4081/5*x^5 + 55205/6*x^6 + ..., where [1, 5, 37, 353, 4081, 55205, ...] = A004208. - Philippe Deléham, Jun 20 2006
1/3 + 2/15 + 3/105 + ... = 1/2. [Jolley eq. 216]
Sum_{j=1..n} j/a(j+1) = (1 - 1/a(n+1))/2. [Jolley eq. 216]
1/1 + 1/3 + 2/15 + 6/105 + 24/945 + ... = Pi/2. - Gary W. Adamson, Dec 21 2006
a(n) = (1/sqrt(2*Pi))*Integral_{x>=0} x^n*exp(-x/2)/sqrt(x). - Paul Barry, Jan 28 2008
a(n) = A006882(2n-1). - R. J. Mathar, Jul 04 2009
G.f.: 1/(1-x-2x^2/(1-5x-12x^2/(1-9x-30x^2/(1-13x-56x^2/(1- ... (continued fraction). - Paul Barry, Sep 18 2009
a(n) = (-1)^n*subs({log(e)=1,x=0},coeff(simplify(series(e^(x*t-t^2/2),t,2*n+1)),t^(2*n))*(2*n)!). - Leonid Bedratyuk, Oct 31 2009
a(n) = 2^n*gamma(n+1/2)/gamma(1/2). - Jaume Oliver Lafont, Nov 09 2009
G.f.: 1/(1-x/(1-2x/(1-3x/(1-4x/(1-5x/(1- ...(continued fraction). - Aoife Hennessy (aoife.hennessy(AT)gmail.com), Dec 02 2009
The g.f. of a(n+1) is 1/(1-3x/(1-2x/(1-5x/(1-4x/(1-7x/(1-6x/(1-.... (continued fraction). - Paul Barry, Dec 04 2009
a(n) = Sum_{i=1..n} binomial(n,i)*a(i-1)*a(n-i). - Vladimir Shevelev, Sep 30 2010
E.g.f.: A(x) = 1 - sqrt(1-2*x) satisfies the differential equation A'(x) - A'(x)*A(x) - 1 = 0. - Vladimir Kruchinin, Jan 17 2011
a(n) = A123023(2*n). - Michael Somos, Jul 24 2011
a(n) = (1/2)*Sum_{i=1..n} binomial(n+1,i)*a(i-1)*a(n-i). See link above. - Dennis P. Walsh, Dec 02 2011
a(n) = Sum_{k=0..n} (-1)^k*binomial(2*n,n+k)*Stirling_1(n+k,k) [Kauers and Ko].
a(n) = A035342(n, 1), n >= 1 (first column of triangle).
a(n) = A001497(n, 0) = A001498(n, n), first column, resp. main diagonal, of Bessel triangle.
From Gary W. Adamson, Jul 19 2011: (Start)
a(n) = upper left term of M^n and sum of top row terms of M^(n-1), where M = a variant of the (1,2) Pascal triangle (Cf. A029635) as the following production matrix:
1, 2, 0, 0, 0, ...
1, 3, 2, 0, 0, ...
1, 4, 5, 2, 0, ...
1, 5, 9, 7, 2, ...
...
For example, a(3) = 15 is the left term in top row of M^3: (15, 46, 36, 8) and a(4) = 105 = (15 + 46 + 36 + 8).
(End)
G.f.: A(x) = 1 + x/(W(0) - x); W(k) = 1 + x + x*2*k - x*(2*k + 3)/W(k+1); (continued fraction). - Sergei N. Gladkovskii, Nov 17 2011
a(n) = Sum_{i=1..n} binomial(n,i-1)*a(i-1)*a(n-i). - Dennis P. Walsh, Dec 02 2011
a(n) = A009445(n) / A014481(n). - Reinhard Zumkeller, Dec 03 2011
a(n) = (-1)^n*Sum_{k=0..n} 2^(n-k)*s(n+1,k+1), where s(n,k) are the Stirling numbers of the first kind, A048994. - Mircea Merca, May 03 2012
a(n) = (2*n)_4! = Gauss_factorial(2*n,4) = Product_{j=1..2*n, gcd(j,4)=1} j. - Peter Luschny, Oct 01 2012
G.f.: (1 - 1/Q(0))/x where Q(k) = 1 - x*(2*k - 1)/(1 - x*(2*k + 2)/Q(k+1) ); (continued fraction). - Sergei N. Gladkovskii, Mar 19 2013
G.f.: 1 + x/Q(0), where Q(k) = 1 + (2*k - 1)*x - 2*x*(k + 1)/Q(k+1); (continued fraction). - Sergei N. Gladkovskii, May 01 2013
G.f.: 2/G(0), where G(k) = 1 + 1/(1 - 2*x*(2*k + 1)/(2*x*(2*k + 1) - 1 + 2*x*(2*k + 2)/G(k+1))); (continued fraction). - Sergei N. Gladkovskii, May 31 2013
G.f.: G(0)/2, where G(k) = 1 + 1/(1 - x/(x + 1/(2*k + 1)/G(k+1))); (continued fraction). - Sergei N. Gladkovskii, Jun 01 2013
G.f.: G(0), where G(k) = 1 + 2*x*(4*k + 1)/(4*k + 2 - 2*x*(2*k + 1)*(4*k + 3)/(x*(4*k + 3) + 2*(k + 1)/G(k+1))); (continued fraction). - Sergei N. Gladkovskii, Jun 22 2013
a(n) = (2*n - 3)*a(n-2) + (2*n - 2)*a(n-1), n > 1. - Ivan N. Ianakiev, Jul 08 2013
G.f.: G(0), where G(k) = 1 - x*(k+1)/(x*(k+1) - 1/G(k+1) ); (continued fraction). - Sergei N. Gladkovskii, Aug 04 2013
a(n) = 2*a(n-1) + (2n-3)^2*a(n-2), a(0) = a(1) = 1. - Philippe Deléham, Oct 27 2013
G.f. of reciprocals: Sum_{n>=0} x^n/a(n) = 1F1(1; 1/2; x/2), confluent hypergeometric Function. - R. J. Mathar, Jul 25 2014
0 = a(n)*(+2*a(n+1) - a(n+2)) + a(n+1)*(+a(n+1)) for all n in Z. - Michael Somos, Sep 18 2014
a(n) = (-1)^n / a(-n) = 2*a(n-1) + a(n-1)^2 / a(n-2) for all n in Z. - Michael Somos, Sep 18 2014
From Peter Bala, Feb 18 2015: (Start)
Recurrence equation: a(n) = (3*n - 2)*a(n-1) - (n - 1)*(2*n - 3)*a(n-2) with a(1) = 1 and a(2) = 3.
The sequence b(n) = A087547(n), beginning [1, 4, 52, 608, 12624, ... ], satisfies the same second-order recurrence equation. This leads to the generalized continued fraction expansion lim_{n -> infinity} b(n)/a(n) = Pi/2 = 1 + 1/(3 - 6/(7 - 15/(10 - ... - n*(2*n - 1)/((3*n + 1) - ... )))). (End)
E.g.f of the sequence whose n-th element (n = 1,2,...) equals a(n-1) is 1-sqrt(1-2*x). - Stanislav Sykora, Jan 06 2017
Sum_{n >= 1} a(n)/(2*n-1)! = exp(1/2). - Daniel Suteu, Feb 06 2017
a(n) = A028338(n, 0), n >= 0. - Wolfdieter Lang, May 27 2017
a(n) = (Product_{k=0..n-2} binomial(2*(n-k),2))/n!. - Stefano Spezia, Nov 13 2018
a(n) = Sum_{i=0..n-1} Sum_{j=0..n-i-1} C(n-1,i)*C(n-i-1,j)*a(i)*a(j)*a(n-i-j-1), a(0)=1, - Vladimir Kruchinin, May 06 2020
From Amiram Eldar, Jun 29 2020: (Start)
Sum_{n>=1} 1/a(n) = sqrt(e*Pi/2)*erf(1/sqrt(2)), where erf is the error function.
Sum_{n>=1} (-1)^(n+1)/a(n) = sqrt(Pi/(2*e))*erfi(1/sqrt(2)), where erfi is the imaginary error function. (End)
G.f. of reciprocals: R(x) = Sum_{n>=0} x^n/a(n) satisfies (1 + x)*R(x) = 1 + 2*x*R'(x). - Werner Schulte, Nov 04 2024
EXAMPLE
a(3) = 1*3*5 = 15.
From Joerg Arndt, Sep 10 2013: (Start)
There are a(3)=15 involutions of 6 elements without fixed points:
#: permutation transpositions
01: [ 1 0 3 2 5 4 ] (0, 1) (2, 3) (4, 5)
02: [ 1 0 4 5 2 3 ] (0, 1) (2, 4) (3, 5)
03: [ 1 0 5 4 3 2 ] (0, 1) (2, 5) (3, 4)
04: [ 2 3 0 1 5 4 ] (0, 2) (1, 3) (4, 5)
05: [ 2 4 0 5 1 3 ] (0, 2) (1, 4) (3, 5)
06: [ 2 5 0 4 3 1 ] (0, 2) (1, 5) (3, 4)
07: [ 3 2 1 0 5 4 ] (0, 3) (1, 2) (4, 5)
08: [ 3 4 5 0 1 2 ] (0, 3) (1, 4) (2, 5)
09: [ 3 5 4 0 2 1 ] (0, 3) (1, 5) (2, 4)
10: [ 4 2 1 5 0 3 ] (0, 4) (1, 2) (3, 5)
11: [ 4 3 5 1 0 2 ] (0, 4) (1, 3) (2, 5)
12: [ 4 5 3 2 0 1 ] (0, 4) (1, 5) (2, 3)
13: [ 5 2 1 4 3 0 ] (0, 5) (1, 2) (3, 4)
14: [ 5 3 4 1 2 0 ] (0, 5) (1, 3) (2, 4)
15: [ 5 4 3 2 1 0 ] (0, 5) (1, 4) (2, 3)
(End)
G.f. = 1 + x + 3*x^2 + 15*x^3 + 105*x^4 + 945*x^5 + 10395*x^6 + 135135*x^7 + ...
MAPLE
f := n->(2*n)!/(n!*2^n);
A001147 := proc(n) doublefactorial(2*n-1); end: # R. J. Mathar, Jul 04 2009
A001147 := n -> 2^n*pochhammer(1/2, n); # Peter Luschny, Aug 09 2009
G(x):=(1-2*x)^(-1/2): f[0]:=G(x): for n from 1 to 29 do f[n]:=diff(f[n-1], x) od: x:=0: seq(f[n], n=0..19); # Zerinvary Lajos, Apr 03 2009; aligned with offset by Johannes W. Meijer, Aug 11 2009
series(hypergeom([1, 1/2], [], 2*x), x=0, 20); # Mark van Hoeij, Apr 07 2013
MATHEMATICA
Table[(2 n - 1)!!, {n, 0, 19}] (* Robert G. Wilson v, Oct 12 2005 *)
a[ n_] := 2^n Gamma[n + 1/2] / Gamma[1/2]; (* Michael Somos, Sep 18 2014 *)
Join[{1}, Range[1, 41, 2]!!] (* Harvey P. Dale, Jan 28 2017 *)
a[ n_] := If[ n < 0, (-1)^n / a[-n], SeriesCoefficient[ Product[1 - (1 - x)^(2 k - 1), {k, n}], {x, 0, n}]]; (* Michael Somos, Jun 27 2017 *)
(2 Range[0, 20] - 1)!! (* Eric W. Weisstein, Jul 22 2017 *)
PROG
(PARI) {a(n) = if( n<0, (-1)^n / a(-n), (2*n)! / n! / 2^n)}; /* Michael Somos, Sep 18 2014 */
(PARI) x='x+O('x^33); Vec(serlaplace((1-2*x)^(-1/2))) \\ Joerg Arndt, Apr 24 2011
(Magma) A001147:=func< n | n eq 0 select 1 else &*[ k: k in [1..2*n-1 by 2] ] >; [ A001147(n): n in [0..20] ]; // Klaus Brockhaus, Jun 22 2011
(Magma) I:=[1, 3]; [1] cat [n le 2 select I[n] else (3*n-2)*Self(n-1)-(n-1)*(2*n-3)*Self(n-2): n in [1..25] ]; // Vincenzo Librandi, Feb 19 2015
(Haskell)
a001147 n = product [1, 3 .. 2 * n - 1]
a001147_list = 1 : zipWith (*) [1, 3 ..] a001147_list
-- Reinhard Zumkeller, Feb 15 2015, Dec 03 2011
(Sage) [rising_factorial(n+1, n)/2^n for n in (0..15)] # Peter Luschny, Jun 26 2012
(Python)
from sympy import factorial2
def a(n): return factorial2(2 * n - 1)
print([a(n) for n in range(101)]) # Indranil Ghosh, Jul 22 2017
(GAP) A001147 := function(n) local i, s, t; t := 1; i := 0; Print(t, ", "); for i in [1 .. n] do t := t*(2*i-1); Print(t, ", "); od; end; A001147(100); # Stefano Spezia, Nov 13 2018
(Maxima)
a(n):=if n=0 then 1 else sum(sum(binomial(n-1, i)*binomial(n-i-1, j)*a(i)*a(j)*a(n-i-j-1), j, 0, n-i-1), i, 0, n-1); /* Vladimir Kruchinin, May 06 2020 */
CROSSREFS
Cf. A086677; A055142 (for this sequence, |a(n+1)| + 1 is the number of distinct products which can be formed using commutative, nonassociative multiplication and a nonempty subset of n given variables).
Constant terms of polynomials in A098503. First row of array A099020.
Subsequence of A248652.
Cf. A082161 (relaxed compacted binary trees of unbounded right height).
Cf. A053871 (binomial transform).
KEYWORD
nonn,easy,nice,core,changed
EXTENSIONS
Removed erroneous comments: neither the number of n X n binary matrices A such that A^2 = 0 nor the number of simple directed graphs on n vertices with no directed path of length two are counted by this sequence (for n = 3, both are 13). - Dan Drake, Jun 02 2009
STATUS
approved
Schroeder's second problem (generalized parentheses); also called super-Catalan numbers or little Schroeder numbers.
(Formerly M2898 N1163)
+10
236
1, 1, 3, 11, 45, 197, 903, 4279, 20793, 103049, 518859, 2646723, 13648869, 71039373, 372693519, 1968801519, 10463578353, 55909013009, 300159426963, 1618362158587, 8759309660445, 47574827600981, 259215937709463, 1416461675464871
OFFSET
0,3
COMMENTS
If you are looking for the Schroeder numbers (a.k.a. large Schroder numbers, or big Schroeder numbers), see A006318.
Yang & Jiang (2021) call these the small 2-Schroeder numbers. - N. J. A. Sloane, Mar 28 2021
There are two schools of thought about the index for the first term. I prefer the indexing a(0) = a(1) = 1, a(2) = 3, a(3) = 11, etc.
a(n) is the number of ways to insert parentheses in a string of n+1 symbols. The parentheses must be balanced but there is no restriction on the number of pairs of parentheses. The number of letters inside a pair of parentheses must be at least 2. Parentheses enclosing the whole string are ignored.
Also length of list produced by a variant of the Catalan producing iteration: replace each integer k with the list 0,1,..,k,k+1,k,...,1,0 and get the length a(n) of the resulting (flattened) list after n iterations. - Wouter Meeussen, Nov 11 2001
Stanley gives several other interpretations for these numbers.
Number of Schroeder paths of semilength n (i.e., lattice paths from (0,0) to (2n,0), with steps H=(2,0), U=(1,1) and D(1,-1) and not going below the x-axis) with no peaks at level 1. Example: a(2)=3 because among the six Schroeder paths of semilength two HH, UHD, UUDD, HUD, UDH and UDUD, only the first three have no peaks at level 1. - Emeric Deutsch, Dec 27 2003
a(n+1) is the number of Dyck n-paths in which the interior vertices of the ascents are colored white or black. - David Callan, Mar 14 2004
Number of possible schedules for n time slots in the first-come first-served (FCFS) printer policy.
Also row sums of A086810, A033282, A126216. - Philippe Deléham, May 09 2004
a(n+1) is the number of pairs (u,v) of same-length compositions of n, 0's allowed in u but not in v and u dominates v (meaning u_1 >= v_1, u_1 + u_2 >= v_1 + v_2 and so on). For example, with n=2, a(3) counts (2,2), (1+1,1+1), (2+0,1+1). - David Callan, Jul 20 2005
The big Schroeder number (A006318) is the number of Schroeder paths from (0,0) to (n,n) (subdiagonal paths with steps (1,0) (0,1) and (1,1)). These paths fall in two classes: those with steps on the main diagonal and those without. These two classes are equinumerous and the number of paths in either class is the little Schroeder number a(n) (half the big Schroeder number). - Marcelo Aguiar (maguiar(AT)math.tamu.edu), Oct 14 2005
With offset 0, a(n) = number of (colored) Motzkin (n-1)-paths with each upstep U getting one of 2 colors and each flatstep F getting one of 3 colors. Example. With their colors immediately following upsteps/flatsteps, a(2) = 3 counts F1, F2, F3 and a(3)=11 counts U1D, U2D, F1F1, F1F2, F1F3, F2F1, F2F2, F2F3, F3F1, F3F2, F3F3. - David Callan, Aug 16 2006
Shifts left when INVERT transform applied twice. - Alois P. Heinz, Apr 01 2009
Number of increasing tableaux of shape (n,n). An increasing tableau is a semistandard tableaux with strictly increasing rows and columns, and set of entries an initial segment of the positive integers. Example: a(2) = 3 because of the three tableaux (12)(34), (13)(24), (12)(23). - Oliver Pechenik, Apr 22 2014
Number of ordered trees with no vertex of outdegree 1 and having n+1 leaves (called sometimes Schröder trees). - Emeric Deutsch, Dec 13 2014
Number of dissections of a convex (n+2)-gon by nonintersecting diagonals. Example: a(2)=3 because for a square ABCD we have (i) no diagonal, (ii) dissection with diagonal AC, and (iii) dissection with diagonal BD. - Emeric Deutsch, Dec 13 2014
The little Schroeder numbers are the moments of the Marchenko-Pastur law for the case c=2 (although the moment m0 is 1/2 instead of 1): 1/2, 1, 3, 11, 45, 197, 903, ... - Jose-Javier Martinez, Apr 07 2015
Number of generalized Motzkin paths with no level steps at height 0, from (0,0) to (2n,0), and consisting of steps U=(1,1), D=(1,-1) and H2=(2,0). For example, for n=3, we have the 11 paths: UDUDUD, UUDDUD, UDUUDD, UH2DUD, UDUH2D, UH2H2D, UUDUDD, UUUDDD, UUH2DD, UUDH2D, UH2UDD. - José Luis Ramírez Ramírez, Apr 20 2015
REVERT transform of A225883. - Vladimir Reshetnikov, Oct 25 2015
Total number of (nonempty) faces of all dimensions in the associahedron K_{n+1} of dimension n-1. For example, K_4 (a pentagon) includes 5 vertices and 5 edges together with K_4 itself (5 + 5 + 1 = 11), while K_5 includes 14 vertices, 21 edges and 9 faces together with K_5 itself (14 + 21 + 9 + 1 = 45). - Noam Zeilberger, Sep 17 2018
a(n) is the number of interval posets of permutations with n minimal elements that have exactly two realizers, up to a shift by 1 in a(4). See M. Bouvel, L. Cioni, B. Izart, Theorem 17 page 13. - Mathilde Bouvel, Oct 21 2021
a(n) is the number of sequences of nonnegative integers (u_1, u_2, ..., u_n) such that (i) u_1 = 1, (ii) u_i <= i for all i, (iii) the nonzero u_i are weakly increasing. For example, a(2) = 3 counts 10, 11, 12, and a(3) = 11 counts 100, 101, 102, 103, 110, 111, 112, 113, 120, 122, 123. See link below. - David Callan, Dec 19 2021
a(n) is the number of parking functions of size n avoiding the patterns 132 and 213. - Lara Pudwell, Apr 10 2023
a(n+1) is the number of Schroeder paths from (0,0) to (2n,0) in which level steps at height 0 come in 2 colors. - Alexander Burstein, Jul 23 2023
REFERENCES
D. Arques and A. Giorgetti, Une bijection géometrique entre une famille d'hypercartes et une famille de polygones énumérées par la série de Schroeder, Discrete Math., 217 (2000), 17-32.
P Barry, Riordan arrays, generalized Narayana triangles, and series reversion, Linear Algebra and its Applications, 491 (2016) 343-385.
N. Bernasconi et al., On properties of random dissections and triangulations, Combinatorica, 30 (6) (2010), 627-654.
Miklos Bona, editor, Handbook of Enumerative Combinatorics, CRC Press, 2015, page 618.
Cameron, Peter J. Some treelike objects. Quart. J. Math. Oxford Ser. (2) 38 (1987), no. 150, 155--183. MR0891613 (89a:05009). See p. 155, also p. 179, line -9. - N. J. A. Sloane, Apr 18 2014
C. Coker, A family of eigensequences, Discrete Math. 282 (2004), 249-250.
L. Comtet, Advanced Combinatorics, Reidel, 1974, p. 57.
D. E. Davenport, L. W. Shapiro and L. C. Woodson, The Double Riordan Group, The Electronic Journal of Combinatorics, 18(2) (2012), #P33. - From N. J. A. Sloane, May 11 2012
E. Deutsch, A bijective proof of an equation linking the Schroeder numbers, large and small, Discrete Math., 241 (2001), 235-240.
Doslic, Tomislav and Veljan, Darko. Logarithmic behavior of some combinatorial sequences. Discrete Math. 308 (2008), no. 11, 2182--2212. MR2404544 (2009j:05019) - From N. J. A. Sloane, May 01 2012
Drmota, Michael; de Mier, Anna; Noy, Marc. Extremal statistics on non-crossing configurations. Discrete Math. 327 (2014), 103--117. MR3192420. See Eq. (2). - N. J. A. Sloane, May 18 2014
I. M. H. Etherington, On non-associative combinations, Proc. Royal Soc. Edinburgh, 59 (Part 2, 1938-39), 153-162.
I. M. H. Etherington, Some problems of non-associative combinations (I), Edinburgh Math. Notes, 32 (1940), pp. i-vi. Part II is by A. Erdelyi and I. M. H. Etherington, and is on pages vii-xiv of the same issue.
P. Flajolet and M. Noy, Analytic combinatorics of non-crossing permutations, Discrete Math., 204 (1999), 203-229, Section 3.1.
D. Foata and D. Zeilberger, A classic proof of a recurrence for a very classical sequence, J. Comb Thy A 80 380-384 1997
Wolfgang Gatterbauer, Dan Suciu, Dissociation and propagation for approximate lifted inference with standard relational database management systems, The VLDB Journal, February 2017, Volume 26, Issue 1, pp. 5-30; DOI 10.1007/s00778-016-0434-5
Ivan Geffner, Marc Noy, Counting Outerplanar Maps, Electronic Journal of Combinatorics 24(2) (2017), #P2.3
D. Gouyou-Beauchamps and B. Vauquelin, Deux proprietes combinatoires des nombres de Schroeder, Theor. Inform. Appl., 22 (1988), 361-388.
N. S. S. Gu, N. Y. Li and T. Mansour, 2-Binary trees: bijections and related issues, Discr. Math., 308 (2008), 1209-1221.
P.-Y. Huang, S.-C. Liu, Y.-N. Yeh, Congruences of Finite Summations of the Coefficients in certain Generating Functions, The Electronic Journal of Combinatorics, 21 (2014), #P2.45.
M. Klazar, On numbers of Davenport-Schinzel sequences, Discr. Math., 185 (1998), 77-87.
D. E. Knuth, The Art of Computer Programming, Vol. 1, various sections (e.g. p. 534 of 2nd ed.).
D. E. Knuth, The Art of Computer Programming, Vol. 1, (p. 539 of 3rd ed.).
D. E. Knuth, The Art of Computer Programming, Vol. 4A, Section 7.2.1.6, Problem 66, p. 479.
J. S. Lew, Polynomial enumeration of multidimensional lattices, Math. Systems Theory, 12 (1979), 253-270.
Ana Marco, J.-J. Martinez, A total positivity property of the Marchenko-Pastur Law, Electronic Journal of Linear Algebra, 30 (2015), #7.
T. S. Motzkin, Relations between hypersurface cross ratios and a combinatorial formula for partitions of a polygon, for permanent preponderance and for non-associative products, Bull. Amer. Math. Soc., 54 (1948), 352-360.
L. Ozsvart, Counting ordered graphs that avoid certain subgraphs, Discr. Math., 339 (2016), 1871-1877.
R. C. Read, On general dissections of a polygon, Aequat. Mathem. 18 (1978) 370-388, Table 6
J. Riordan, Combinatorial Identities, Wiley, 1968, p. 168.
E. Schroeder, Vier combinatorische Probleme, Zeit. f. Math. Phys., 15 (1870), 361-376.
N. J. A. Sloane, A Handbook of Integer Sequences, Academic Press, 1973 (includes this sequence).
N. J. A. Sloane and Simon Plouffe, The Encyclopedia of Integer Sequences, Academic Press, 1995 (includes this sequence).
R. P. Stanley, Enumerative Combinatorics, Cambridge, Vol. 2, 1999; see page 178; see page 239, Exercise 6.39b.
H. N. V. Temperley and D. G. Rogers, A note on Baxter's generalization of the Temperley-Lieb operators, pp. 324-328 of Combinatorial Mathematics (Canberra, 1977), Lect. Notes Math. 686, 1978.
I. Vardi, Computational Recreations in Mathematica. Addison-Wesley, Redwood City, CA, 1991, p. 198.
Sheng-Liang Yang and Mei-yang Jiang, The m-Schröder paths and m-Schröder numbers, Disc. Math. (2021) Vol. 344, Issue 2, 112209. doi:10.1016/j.disc.2020.112209. See Table 1.
LINKS
Seiichi Manyama, Table of n, a(n) for n = 0..1312 (first 200 terms from T. D. Noe)
J. Abate and W. Whitt, Integer Sequences from Queueing Theory , J. Int. Seq. 13 (2010), 10.5.5, p_n(1).
M. Abramowitz and I. A. Stegun, eds., Handbook of Mathematical Functions, National Bureau of Standards, Applied Math. Series 55, Tenth Printing, 1972 [alternative scanned copy].
Ayomikun Adeniran and Lara Pudwell, Pattern avoidance in parking functions, Enumer. Comb. Appl. 3:3 (2023), Article S2R17.
Marcelo Aguiar and Walter Moreira, Combinatorics of the free Baxter algebra, arXiv:math/0510169 [math.CO], 2005-2007, see Corollary 3.3.iii.
Axel Bacher, Directed and multi-directed animals on the square lattice with next nearest neighbor edges, arXiv preprint arXiv:1301.1365 [math.CO], 2013. - From N. J. A. Sloane, Feb 04 2013
C. Banderier, M. Bousquet-Mélou, A. Denise, P. Flajolet, D. Gardy and D. Gouyou-Beauchamps, Generating functions for generating trees, Discrete Mathematics 246(1-3), March 2002, pp. 29-55.
C. Banderier and D. Merlini, Lattice paths with an infinite set of jumps, FPSAC02, Melbourne, 2002.
E. Barcucci, E. Pergola, R. Pinzani and S. Rinaldi, ECO method and hill-free generalized Motzkin paths, Séminaire Lotharingien de Combinatoire, B46b (2001), 14 pp.
Marilena Barnabei, Flavio Bonetti, Niccolò Castronuovo and Matteo Silimbani, Ascending runs in permutations and valued Dyck paths, Ars Mathematica Contemporanea (2019) Vol. 16, No. 2, 445-463.
Paul Barry, On Integer-Sequence-Based Constructions of Generalized Pascal Triangles, J. Integer Sequ., Vol. 9 (2006), Article 06.2.4.
Paul Barry, On a transformation of Riordan moment sequences, arXiv:1802.03443 [math.CO], 2018.
Paul Barry and Aoife Hennessy, Generalized Narayana Polynomials, Riordan Arrays, and Lattice Paths, Journal of Integer Sequences, Vol. 15, 2012, #12.4.8.
Karin Baur and P. P. Martin, The fibres of the Scott map on polygon tilings are the flip equivalence classes, arXiv preprint arXiv:1601.05080 [math.CO], 2016.
Karin Baur and Paul P. Martin, A generalised Euler-Poincaré formula for associahedra, arXiv:1711.04986 [math.CO], 2017.
Arkady Berenstein, Vladimir Retakh, Christophe Reutenauer and Doron Zeilberger, The Reciprocal of Sum_{n >= 0} a^n b^n for non-commuting a and b, Catalan numbers and non-commutative quadratic equations, arXiv preprint arXiv:1206.4225 [math.CO], 2012.
Julia E. Bergner, Cedric Harper, Ryan Keller and Mathilde Rosi-Marshall, Action graphs, planar rooted forests, and self-convolutions of the Catalan numbers, arXiv:1807.03005 [math.CO], 2018.
F. R. Bernhart & N. J. A. Sloane, Emails, April-May 1994
D. Birmajer, J. B. Gil and M. D. Weiner, Colored partitions of a convex polygon by noncrossing diagonals, arXiv preprint arXiv:1503.05242 [math.CO], 2015.
Daniel Birmajer and Juan B. Gil, Michael D. Weiner, A family of Bell transformations, arXiv:1803.07727 [math.CO], 2018.
Natasha Blitvić and Einar Steingrímsson, Permutations, moments, measures, arXiv:2001.00280 [math.CO], 2020.
J. Bloom and A, Burstein, Egge triples and unbalanced Wilf-equivalence, arXiv preprint arXiv:1410.0230 [math.CO], 2014.
Miklós Bóna, Cheyne Homberger, Jay Pantone, and Vince Vatter, Pattern-avoiding involutions: exact and asymptotic enumeration, arxiv:1310.7003 [math.CO], 2013.
Mathilde Bouvel, Cedric Chauve, Marni Mishna and Dominique Rossin, Average-case analysis of perfect sorting by reversals, arXiv preprint arXiv:1201.0940 [cs.DM], 2012.
M. Bouvel, L. Cioni and B. Izart, The interval posets of permutations seen from the decomposition tree perspective, arXiv:2110.10000 [math.CO], 2021. See Theorem 17 p. 13.
Kevin Brown, Hipparchus on Compound Statements, 1994-2010.
Alexander Burstein and Opel Jones, Enumeration of Dumont permutations avoiding certain four-letter patterns, arXiv:2002.12189 [math.CO], 2020.
Alexander Burstein and Louis W. Shapiro, Pseudo-involutions in the Riordan group, arXiv:2112.11595 [math.CO], 2021.
Freddy Cachazo, Karen Yeats and Samuel Yusim, Compatible Cycles and CHY Integrals, arXiv:1907.12661 [math-ph], 2019.
Fangfang Cai, Qing-Hu Hou, Yidong Sun and Arthur L.B. Yang, Combinatorial identities related to 2X2 submatrices of recursive matrices, arXiv:1808.05736 [math.CO], 2018.
H. Cambazard and N. Catusse, Fixed-Parameter Algorithms for Rectilinear Steiner tree and Rectilinear Traveling Salesman Problem in the Plane, arXiv preprint arXiv:1512.06649 [cs.DS], 2015.
David Callan, Some bijections for lattice paths, arXiv:2112.05241 [math.CO], 2021.
Naiomi T. Cameron and Asamoah Nkwanta, On Some (Pseudo) Involutions in the Riordan Group, Journal of Integer Sequences, Vol. 8 (2005), Article 05.3.7.
P. J. Cameron, Some sequences of integers, Discrete Math., 75 (1989), 89-102.
P. J. Cameron, Some sequences of integers, in "Graph Theory and Combinatorics 1988", ed. B. Bollobas, Annals of Discrete Math., 43 (1989), 89-102.
F. Cazals, Combinatorics of Non-Crossing Configurations, Studies in Automatic Combinatorics, Volume II (1997).
Grégory Chatel, Vincent Pilaud and Viviane Pons, The weak order on integer posets, arXiv:1701.07995 [math.CO], 2017.
W. Y. C. Chen, T. Mansour and S. H. F. Yan, Matchings avoiding partial patterns, arXiv:math/0504342 [math.CO], 2005.
William Y. C. Chen and Carol J. Wang, Noncrossing Linked Partitions and Large (3, 2)-Motzkin Paths, Discrete Math., 312 (2012), 1918-1922. - N. J. A. Sloane, Jun 08 2012
Z. Chen and H. Pan, Identities involving weighted Catalan-Schroder and Motzkin Paths, arXiv:1608.02448 [math.CO] (2016), eq (1.13) a=1, b=2.
J. Cigler, Ramanujan's q-continued fractions and Schröder-like numbers, arXiv:1210.0372 [math.HO], 2012. - N. J. A. Sloane, Dec 29 2012
J. Cigler, Hankel determinants of some polynomial sequences, arXiv:1211.0816 [math.CO], 2012.
Dennis E. Davenport, Louis W. Shapiro and Leon C. Woodson, A bijection between the triangulations of convex polygons and ordered trees, Integers (2020) Vol. 20, Article #A8.
Vesselin Drensky, Graded Algebras, Algebraic Functions, Planar Trees, and Elliptic Integrals, arXiv:2004.05596 [math.RA], 2020, see p. 20.
Rosena R. X. Du, Xiaojie Fan and Yue Zhao, Enumeration on row-increasing tableaux of shape 2 X n, arXiv:1803.01590 [math.CO], 2018.
I. M. H. Etherington, Non-associate powers and a functional equation, Math. Gaz. 21 (1937), 36-39; addendum 21 (1937), 153.
I. M. H. Etherington, Some problems of non-associative combinations (I), Edinburgh Math. Notes, 32 (1940), pp. i-vi. [Annotated scanned copy]. Part II [not scanned] is by A. Erdelyi and I. M. H. Etherington, and is on pages vii-xiv of the same issue.
S.-P. Eu and T.-S. Fu, A simple proof of the Aztec diamond problem, arXiv:math/0412041 [math.CO], 2004.
P. Flajolet and R. Sedgewick, Analytic Combinatorics, 2009; see pages 69, 474-475, etc.
D. Foata and D. Zeilberger, A Classic Proof of a Recurrence for a Very Classical Sequence, arXiv:math/9805015 [math.CO], 1998.
Shishuo Fu and Yaling Wang, Bijective recurrences concerning two Schröder triangles, arXiv:1908.03912 [math.CO], 2019.
N. Gabriel, K. Peske, L. Pudwell and S. Tay, Pattern Avoidance in Ternary Trees, J. Int. Seq. 15 (2012) # 12.1.5.
W. Gatterbauer and D. Suciu, Approximate Lifted Inference with Probabilistic Databases, arXiv preprint arXiv:1412.1069 [cs.DB], 2014.
Joël Gay and Vincent Pilaud, The weak order on Weyl posets, arXiv:1804.06572 [math.CO], 2018.
Evangelos Georgiadis, Akihiro Munemasa and Hajime Tanaka, A note on super Catalan numbers, arXiv:1101.1579 [math.CO], 2011-2012.
Étienne Ghys, A Singular Mathematical Promenade, arXiv:1612.06373, 2016, also, The Mathematical Intelligencer (2018) 40.2, 85-88.
Samuele Giraudo, Pluriassociative algebras II: The polydendriform operad and related operads, arXiv:1603.01394 [math.CO], 2016.
Samuele Giraudo, Tree series and pattern avoidance in syntax trees, arXiv:1903.00677 [math.CO], 2019.
Li Guo and Jun Pei, Averaging algebras, Schroeder numbers and rooted trees, arXiv preprint arXiv:1401.7386 [math.RA], 2014.
Guo-Niu Han, Enumeration of Standard Puzzles [Cached copy]
Aoife Hennessy, A Study of Riordan Arrays with Applications to Continued Fractions, Orthogonal Polynomials and Lattice Paths, Ph. D. Thesis, Waterford Institute of Technology, Oct. 2011.
Cheyne Homberger, Patterns in Permutations and Involutions: A Structural and Enumerative Approach, arXiv preprint 1410.2657 [math.CO], 2014.
St. John Kettle, Letter to N. J. A. Sloane, 1982.
Anton Khoroshkin and Thomas Willwacher, Real moduli space of stable rational curves revisted, arXiv:1905.04499 [math.AT], 2019.
E. Krasko and A. Omelchenko, Brown's Theorem and its Application for Enumeration of Dissections and Planar Trees, The Electronic Journal of Combinatorics, 22 (2015), #P1.17.
G. Kreweras, Sur les hiérarchies de segments, Cahiers du Bureau Universitaire de Recherche Opérationnelle, Institut de Statistique, Université de Paris, #20 (1973).
G. Kreweras, Sur les hiérarchies de segments, Cahiers du Bureau Universitaire de Recherche Opérationnelle, Institut de Statistique, Université de Paris, #20 (1973). (Annotated scanned copy)
G. Kreweras, Les préordres totaux compatibles avec un ordre partiel, Math. Sci. Humaines No. 53 (1976), 5-30.
G. Kreweras, Letter to N. J. A. Sloane, 1978.
V. V. Kruchinin and D. V. Kruchinin, A Method for Obtaining Generating Function for Central Coefficients of Triangles, arXiv preprint arXiv:1206.0877 [math.CO], 2012, and J. Int. Seq. 15 (2012) #12.9.3
Huyile Liang, Jeffrey Remmel and Sainan Zheng, Stieltjes moment sequences of polynomials, arXiv:1710.05795 [math.CO], 2017, see page 11.
A. Marco and J.-J. Martinez, A total positivity property of the Marchenko-Pastur Law, Electronic Journal of Linear Algebra, Volume 30 (2015), pp. 106-117.
Peter McCalla and Asamoah Nkwanta, Catalan and Motzkin Integral Representations, arXiv:1901.07092 [math.NT], 2019.
D. Merlini, R. Sprugnoli and M. C. Verri, Waiting patterns for a printer, FUN with algorithm'01, Isola d'Elba, 2001.
W. Mlotkowski and K. A. Penson, The probability measure corresponding to 2-plane trees, ArXiv preprint arXiv:1304.6544 [math.PR], 2013.
T. Motzkin, The hypersurface cross ratio, Bull. Amer. Math. Soc., 51 (1945), 976-984.
Hanna Mularczyk, Lattice Paths and Pattern-Avoiding Uniquely Sorted Permutations, arXiv:1908.04025 [math.CO], 2019.
Jean-Christophe Novelli and Jean-Yves Thibon, Duplicial algebras and Lagrange inversion, arXiv preprint arXiv:1209.5959 [math.CO], 2012.
J.-C. Novelli and J.-Y. Thibon, Hopf Algebras of m-permutations,(m+1)-ary trees, and m-parking functions, arXiv preprint arXiv:1403.5962 [math.CO], 2014.
P. Peart and W.-J. Woan, Generating Functions via Hankel and Stieltjes Matrices, J. Integer Seqs., Vol. 3 (2000), #00.2.1.
O. Pechenik, Cyclic sieving of increasing tableaux and small Schröder paths, arXiv:1209.1355 [math.CO], 2012-2014.
O. Pechenik, Cyclic sieving of increasing tableaux and small Schröder paths, J. Combin. Theory A, 125 (2014), 357-378.
R. A. Perez, A brief but historic article of Siegel, Notices AMS, 58 (2011), 558-566.
E. Pergola and R. A. Sulanke, Schroeder Triangles, Paths and Parallelogram Polyominoes, J. Integer Sequences, 1 (1998), #98.1.7.
Vincent Pilaud, Pebble trees, arXiv:2205.06686 [math.CO], 2022.
Vincent Pilaud and V. Pons, Permutrees, arXiv preprint arXiv:1606.09643 [math.CO], 2016.
Feng Qi, Xiao-Ting Shi, and Bai-Ni Guo, Integral representations of the large and little Schroder numbers, Preprint, 2016.
Feng Qi and Bai-Ni Guo, Some explicit and recursive formulas of the large and little Schröder numbers, Arab Journal of Mathematical Sciences, June 2016.
E. Schröder, Vier combinatorische Probleme, Z. f. Math. Phys., 15 (1870), 361-376. [Annotated scanned copy]
L. W. Shapiro & N. J. A. Sloane, Correspondence, 1976
M. Shattuck, On the zeros of some polynomials with combinatorial coefficients, Annales Mathematicae et Informaticae, 42 (2013) pp. 93-101.
N. J. A. Sloane, The On-Line Encyclopedia of Integer Sequences, arXiv:math/0312448 [math.CO], 2003.
N. J. A. Sloane, Transforms
L. M. Smiley, Variants of Schroeder Dissections, arXiv:math/9907057 [math.CO], 1999.
Michael Z. Spivey and Laura L. Steil, The k-Binomial Transforms and the Hankel Transform, Journal of Integer Sequences, Vol. 9 (2006), Article 06.1.1.
R. P. Stanley, Hipparchus, Plutarch, Schröder and Hough, Am. Math. Monthly, Vol. 104, No. 4, p. 344, 1997.
R. P. Stanley, Hipparchus, Plutarch, Schröder and Hough, Amer. Math. Monthly, 104, 1997, 344-350.
Y. Sun and Z. Wang, Consecutive pattern avoidances in non-crossing trees, Graph. Combinat. 26 (2010) 815-832
Anthony Van Duzer, Subtrees of a Given size in Schroeder Trees, arXiv:1904.05525 [math.CO], 2019.
Eric Weisstein's World of Mathematics, Bracketing
Eric Weisstein's World of Mathematics, Super Catalan Number
Wen-jin Woan, A Recursive Relation for Weighted Motzkin Sequences Journal of Integer Sequences, Vol. 8 (2005), Article 05.1.6.
Wen-jin Woan, A Relation Between Restricted and Unrestricted Weighted Motzkin Paths, Journal of Integer Sequences, Vol. 9 (2006), Article 06.1.7.
E. X. W. Xia and O. X. M. Yao, A Criterion for the Log-Convexity of Combinatorial Sequences, The Electronic Journal of Combinatorics, 20 (2013), #P3.
FORMULA
D-finite with recurrence: (n+1) * a(n) = (6*n-3) * a(n-1) - (n-2) * a(n-2) if n>1. a(0) = a(1) = 1.
a(n) = 3*a(n-1) + 2*A065096(n-2) (n>2). If g(x) = 1 + 3*x + 11*x^2 + 45*x^3 + ... + a(n)*x^n + ..., then g(x) = 1 + 3(x*g(x)) + 2(x*g(x))^2, g(x)^2 = 1 + 6*x + 31*x^2 + 156*x^3 + ... + A065096(n)*x^n + ... - Paul D. Hanna, Jun 10 2002
a(n+1) = -a(n) + 2*Sum_{k=1..n} a(k)*a(n+1-k). - Philippe Deléham, Jan 27 2004
a(n-2) = (1/(n-1))*Sum_{k=0..n-3} binomial(n-1,k+1)*binomial(n-3,k)*2^(n-3-k) for n >= 3 [G. Polya, Elemente de Math., 12 (1957), p. 115.] - N. J. A. Sloane, Jun 13 2015
G.f.: (1 + x - sqrt(1 - 6*x + x^2) )/(4*x) = 2/(1 + x + sqrt(1 - 6*x + x^2)).
a(n) ~ W*(3+sqrt(8))^n*n^(-3/2) where W = (1/4)*sqrt((sqrt(18)-4)/Pi) [See Knuth I, p. 534, or Perez. Note that the formula on line 3, page 475 of Flajolet and Sedgewick seems to be wrong - it has to be multiplied by 2^(1/4).] - N. J. A. Sloane, Apr 10 2011
The correct asymptotic for this sequence is a(n) ~ W*(3+sqrt(8))^n*n^(-3/2), where W = (1+sqrt(2))/(2*2^(3/4)*sqrt(Pi)) = 0.404947065905750651736243... Result in book by D. Knuth (p. 539 of 3rd edition, exercise 12) is for sequence b(n), but a(n) = b(n+1)/2. Therefore is asymptotic a(n) ~ b(n) * (3+sqrt(8))/2. - Vaclav Kotesovec, Sep 09 2012
The Hankel transform of this sequence gives A006125 = 1, 1, 2, 8, 64, 1024, ...; example: det([1, 1, 3, 11; 1, 3, 11, 45; 3, 11, 45, 197; 11, 45, 197, 903]) = 2^6 = 64. - Philippe Deléham, Mar 02 2004
a(n+1) = Sum_{k=0..floor((n-1)/2)} 2^k * 3^(n-1-2k) * binomial(n-1, 2k) * Catalan(k). This formula counts colored Dyck paths by the same parameter by which Touchard's identity counts ordinary Dyck paths: number of DDUs (U=up step, D=down step). See also Gouyou-Beauchamps reference. - David Callan, Mar 14 2004
From Paul Barry, May 24 2005: (Start)
a(n) = (1/(n+1))*Sum_{k=0..n} C(n+1, k)*C(2n-k, n)*(-1)^k*2^(n-k) [with offset 0].
a(n) = (1/(n+1))*Sum_{k=0..n} C(n+1, k+1)*C(n+k, k)*(-1)^(n-k)*2^k [with offset 0].
a(n) = Sum_{k=0..n} (1/(k+1))*C(n, k)*C(n+k, k)*(-1)^(n-k)*2^k [with offset 0].
a(n) = Sum_{k=0..n} A088617(n, k)*(-1)^(n-k)*2^k [with offset 0]. (End)
E.g.f. of a(n+1) is exp(3*x)*BesselI(1, 2*sqrt(2)*x)/(sqrt(2)*x). - Vladeta Jovovic, Mar 31 2004
Reversion of (x-2*x^2)/(1-x) is g.f. offset 1.
For n>=1, a(n) = Sum_{k=0..n} 2^k*N(n, k) where N(n, k) = (1/n)*C(n, k)*C(n, k+1) are the Narayana numbers (A001263). - Benoit Cloitre, May 10 2003 [This formula counts colored Dyck paths by number of peaks, which is easy to see because the Narayana numbers count Dyck paths by number of peaks and the number of peaks determines the number of interior ascent vertices.]
a(n) = Sum_{k=0..n} A088617(n, k)*2^k*(-1)^(n-k). - Philippe Deléham, Jan 21 2004
For n > 0, a(n) = (1/(n+1)) * Sum_{k = 0 .. n-1} binomial(2*n-k, n) * binomial(n-1, k). This formula counts colored Dyck paths (as above) by number of white vertices. - David Callan, Mar 14 2004
a(n-1) = (d^(n-1)/dx^(n-1))((1-x)/(1-2*x))^n/n!|_{x=0}. (For a proof see the comment on the unsigned row sums of triangle A111785.)
From Wolfdieter Lang, Sep 12 2005: (Start)
a(n) = (1/n)*Sum_{k=1..n} binomial(n, k)*binomial(n+k, k-1).
a(n) = hypergeom([1-n, n+2], [2], -1), n>=1. (End)
a(n) = hypergeom([1-n, -n], [2], 2) for n>=0. - Peter Luschny, Sep 22 2014
a(m+n+1) = Sum_{k>=0} A110440(m, k)*A110440(n, k)*2^k = A110440(m+n, 0). - Philippe Deléham, Sep 14 2005
Sum over partitions formula (reference Schroeder paper p. 362, eq. (1) II). Number the partitions of n according to Abramowitz-Stegun pp. 831-832 (see reference under A105805) with k=1..p(n)= A000041(n). For n>=1: a(n-1) = Sum_{k=2..p(n)} A048996(n,k)*a(1)^e(k, 1)*a(1)^e(k, 2)*...*a(n-2)^e(k, n-1) if the k-th partition of n in the mentioned order is written as (1^e(k, 1), 2^e(k, 2), ..., (n-1)e(k, n-1)). Note that the first (k=1) partition (n^1) has to be omitted. - Wolfdieter Lang, Aug 23 2005
Starting (1, 3, 11, 45, ...), = row sums of triangle A126216 = A001263 * [1, 2, 4, 8, 16, ...]. - Gary W. Adamson, Nov 30 2007
From Paul Barry, May 15 2009: (Start)
G.f.: 1/(1+x-2x/(1+x-2x/(1+x-2x/(1+x-2x/(1-.... (continued fraction).
G.f.: 1/(1-x/(1-x-x/(1-x-x/(1-x-x/(1-... (continued fraction).
G.f.: 1/(1-x-2x^2/(1-3x-2x^2/(1-3x-2x^2/(1-... (continued fraction). (End)
G.f.: 1 / (1 - x / (1 - 2*x / (1 - x / (1 - 2*x / ... )))). - Michael Somos, May 19 2013
a(n) = (LegendreP(n+1,3)-3*LegendreP(n,3))/(4*n) for n>0. - Mark van Hoeij, Jul 12 2010 [This formula is mentioned in S.-J. Kettle's 1982 letter - see link. N. J. A. Sloane, Jun 13 2015]
From Gary W. Adamson, Jul 08 2011: (Start)
a(n) = upper left term in M^n, where M is the production matrix:
1, 1, 0, 0, 0, 0, ...
2, 2, 2, 0, 0, 0, ...
1, 1, 1, 1, 0, 0, ...
2, 2, 2, 2, 2, 0, ...
1, 1, 1, 1, 1, 1, ...
... (End)
From Gary W. Adamson, Aug 23 2011: (Start)
a(n) is the sum of top row terms of Q^(n-1), where Q is the infinite square production matrix:
1, 2, 0, 0, 0, ...
1, 1, 2, 0, 0, ...
1, 1, 1, 2, 0, ...
1, 1, 1, 1, 2, ...
... (End)
Let h(t) = (1-t)^2/(2*(1-t)^2-1) = 1/(1-(2*t+3*t^2+4*t^3+...)), an o.g.f. for A003480, then for A001003 a(n) = (1/n!)*((h(t)*d/dt)^n) t, evaluated at t=0, with initial n=1. (Cf. A086810.) - Tom Copeland, Sep 06 2011
A006318(n) = 2*a(n) if n>0. - Michael Somos, Mar 31 2007
BINOMIAL transform is A118376 with offset 0. REVERT transform is A153881. INVERT transform is A006318. INVERT transform of A114710. HANKEL transform is A139685. PSUM transform is A104858. - Michael Somos, May 19 2013
G.f.: 1 + x/(Q(0) - x) where Q(k) = 1 + k*(1-x) - x - x*(k+1)*(k+2)/Q(k+1) ; (continued fraction). - Sergei N. Gladkovskii, Mar 14 2013
a(n) = A144944(n,n) = A186826(n,0). - Reinhard Zumkeller, May 11 2013
a(n)=(-1)^n*LegendreP(n,-1,-3)/sqrt(2), n > 0, LegendreP(n,a,b) is the Legendre function. - Karol A. Penson, Jul 06 2013
Integral representation as n-th moment of a positive weight function W(x) = W_a(x) + W_c(x), where W_a(x) = Dirac(x)/2, is the discrete (atomic) part, and W_c(x) = sqrt(8-(x-3)^2)/(4*Pi*x) is the continuous part of W(x) defined on (3 sqrt(8),3+sqrt(8)): a(n) = int( x^n*W_a(x), x=-eps..eps ) + int( x^n*W_c(x), x = 3-sqrt(8)..3+sqrt(8) ), for any eps>0, n>=0. W_c(x) is unimodal, of bounded variation and W_c(3-sqrt(8)) = W_c(3+sqrt(8)) = 0. Note that the position of the Dirac peak (x=0) lies outside support of W_c(x). - Karol A. Penson and Wojciech Mlotkowski, Aug 05 2013
G.f.: 1 + x/G(x) with G(x) = 1 - 3*x - 2*x^2/G(x) (continued fraction). - Nikolaos Pantelidis, Dec 17 2022
EXAMPLE
G.f. = 1 + x + 3*x^2 + 11*x^3 + 45*x^4 + 197*x^5 + 903*x^6 + 4279*x^7 + ...
a(2) = 3: abc, a(bc), (ab)c; a(3) = 11: abcd, (ab)cd, a(bc)d, ab(cd), (ab)(cd), a(bcd), a(b(cd)), a((bc)d), (abc)d, (a(bc))d, ((ab)c)d.
Sum over partitions formula: a(3) = 2*a(0)*a(2) + 1*a(1)^2 + 3*(a(0)^2)*a(1) + 1*a(0)^4 = 6 + 1 + 3 + 1 = 11.
a(4) = 45 since the top row of Q^3 = (11, 14, 12, 8, 0, 0, 0, ...); (11 + 14 + 12 + 8) = 45.
MAPLE
t1 := (1/(4*x))*(1+x-sqrt(1-6*x+x^2)); series(t1, x, 40);
invtr:= proc(p) local b; b:= proc(n) option remember; local i; `if`(n<1, 1, add(b(n-i) *p(i-1), i=1..n+1)) end end: a:='a': f:= (invtr@@2)(a): a:= proc(n) if n<0 then 1 else f(n-1) fi end: seq(a(n), n=0..30); # Alois P. Heinz, Apr 01 2009
# Computes n -> [a[0], a[1], .., a[n]]
A001003_list := proc(n) local j, a, w; a := array(0..n); a[0] := 1;
for w from 1 to n do a[w] := a[w-1]+2*add(a[j]*a[w-j-1], j=1..w-1) od;
convert(a, list) end: A001003_list(100); # Peter Luschny, May 17 2011
MATHEMATICA
Table[Length[Flatten[Nest[ #/.a_Integer:> Join[Range[0, a + 1], Range[a, 0, -1]] &, {0}, n]]], {n, 0, 10}]; Sch[ 0 ] = Sch[ 1 ] = 1; Sch[ n_Integer ] := Sch[ n ] = (3(2n - 1)Sch[ n - 1 ] - (n - 2)Sch[ n - 2 ])/(n + 1); Array[ Sch, 24, 0]
(* Second program: *)
a[n_] := Hypergeometric2F1[-n + 1, n + 2, 2, -1]; a[0] = 1; Table[a[n], {n, 0, 23}] (* Jean-François Alcover, Nov 09 2011, after Vladeta Jovovic *)
a[ n_] := SeriesCoefficient[ (1 + x - Sqrt[1 - 6 x + x^2]) / (4 x), {x, 0, n}]; (* Michael Somos, Aug 26 2015 *)
Table[(KroneckerDelta[n] - GegenbauerC[n+1, -1/2, 3])/4, {n, 0, 20}] (* Vladimir Reshetnikov, Oct 25 2015 *)
a[n_] := -LegendreP[n, -1, 2, 3] I / Sqrt[2]; a[0] = 1;
Table[a[n], {n, 0, 23}] (* Jean-François Alcover, Feb 16 2019 *)
a[1]:=1; a[2]:=1; a[n_]:=a[n] = a[n-1]+2 Sum[a[k] a[n-k], {k, 2, n-1}]; Map[a, Range[24]] (* Oliver Seipel, Nov 03 2024, after Schröder 1870 *)
PROG
(PARI) {a(n) = if( n<1, n==0, sum( k=0, n, 2^k * binomial(n, k) * binomial(n, k-1) ) / (2*n))}; /* Michael Somos, Mar 31 2007 */
(PARI) {a(n) = my(A); if( n<1, n==0, n--; A = x * O(x^n); n! * simplify( polcoef( exp(3*x + A) * besseli(1, 2*x * quadgen(8) + A), n)))}; /* Michael Somos, Mar 31 2007 */
(PARI) {a(n) = if( n<0, 0, n++; polcoef( serreverse( (x - 2*x^2) / (1 - x) + x * O(x^n)), n))}; /* Michael Somos, Mar 31 2007 */
(PARI) N=30; x='x+O('x^N); Vec( (1+x-(1-6*x+x^2)^(1/2))/(4*x) ) \\ Hugo Pfoertner, Nov 19 2018
(Python) # The objective of this implementation is efficiency.
# n -> [a(0), a(1), ..., a(n)]
def A001003_list(n):
a = [0 for i in range(n)]
a[0] = 1
for w in range(1, n):
s = 0
for j in range(1, w):
s += a[j]*a[w-j-1]
a[w] = a[w-1]+2*s
return a
# Peter Luschny, May 17 2011
(Sage) # Generalized algorithm of L. Seidel
def A001003_list(n) :
D = [0]*(n+1); D[1] = 1/2
b = True; h = 2; R = [1]
for i in range(2*n-2) :
if b :
for k in range(h, 0, -1) : D[k] += D[k-1]
h += 1;
else :
for k in range(1, h, 1) : D[k] += D[k-1]
R.append(D[h-1]);
b = not b
return R
A001003_list(24) # Peter Luschny, Jun 02 2012
(Haskell)
a001003 = last . a144944_row -- Reinhard Zumkeller, May 11 2013
(Python)
from gmpy2 import divexact
A001003 = [1, 1]
for n in range(3, 10**3):
A001003.append(divexact(A001003[-1]*(6*n-9)-(n-3)*A001003[-2], n))
# Chai Wah Wu, Sep 01 2014
(Magma)
R<x>:=PowerSeriesRing(Rationals(), 50);
Coefficients(R!( (1+x -Sqrt(1-6*x+x^2) )/(4*x) )); // G. C. Greubel, Oct 27 2024
CROSSREFS
See A000081, A000108, A001190, A001699, for other ways to count parentheses.
Row sums of A033282, A033877, A086810, A126216.
Right-hand column 1 of convolution triangle A011117.
Column 1 of A336573. Column 0 of A104219.
The sequences listed in Yang-Jiang's Table 1 appear to be A006318, this sequence, A027307, A034015, A144097, A243675, A260332, A243676. - N. J. A. Sloane, Mar 28 2021
Cf. A006318 (Schroeder numbers).
KEYWORD
nonn,easy,nice,core
STATUS
approved

Search completed in 0.115 seconds