|
|
A000262
|
|
Number of "sets of lists": number of partitions of {1,...,n} into any number of lists, where a list means an ordered subset.
(Formerly M2950 N1190)
|
|
250
|
|
|
1, 1, 3, 13, 73, 501, 4051, 37633, 394353, 4596553, 58941091, 824073141, 12470162233, 202976401213, 3535017524403, 65573803186921, 1290434218669921, 26846616451246353, 588633468315403843, 13564373693588558173, 327697927886085654441, 8281153039765859726341
(list;
graph;
refs;
listen;
history;
text;
internal format)
|
|
|
OFFSET
|
0,3
|
|
COMMENTS
|
Determinant of n X n matrix M=[m(i,j)] where m(i,i)=i, m(i,j)=1 if i > j, m(i,j)=i-j if j > i. - Vladeta Jovovic, Jan 19 2003
With p(n) = the number of integer partitions of n, d(i) = the number of different parts of the i-th partition of n, m(i,j) = multiplicity of the j-th part of the i-th partition of n, Sum_{i=1..p(n)} = sum over i and Product_{j=1..d(i)} = product over j, one has: a(n) = Sum_{i=1..p(n)} n!/(Product_{j=1..d(i)} m(i,j)!). - Thomas Wieder, May 18 2005
Consider all n! permutations of the integer sequence [n] = 1,2,3,...,n. The i-th permutation, i=1,2,...,n!, consists of Z(i) permutation cycles. Such a cycle has the length lc(i,j), j=1,...,Z(i). For a given permutation we form the product of all its cycle lengths Product_{j=1..Z(i)} lc(i,j). Furthermore, we sum up all such products for all permutations of [n] which gives Sum_{i=1..n!} Product_{j=1..Z(i)} lc(i,j) = A000262(n). For n=4 we have Sum_{i=1..n!} Product_{j=1..Z(i)} lc(i,j) = 1*1*1*1 + 2*1*1 + 3*1 + 2*1*1 + 3*1 + 2*1 + 3*1 + 4 + 3*1 + 4 + 2*2 + 2*1*1 + 3*1 + 4 + 3*1 + 2*1*1 + 2*2 + 4 + 2*2 + 4 + 3*1 + 2*1*1 + 3*1 + 4 = 73 = A000262(4). - Thomas Wieder, Oct 06 2006
For a finite set S of size n, a chain gang G of S is a partially ordered set (S,<=) consisting only of chains. The number of chain gangs of S is a(n). For example, with S={a, b}and n=2, there are a(2)=3 chain gangs of S, namely, {(a,a),(b,b)}, {(a,a),(a,b),(b,b)} and {(a,a),(b,a),(b,b)}. - Dennis P. Walsh, Feb 22 2007
(-1)*A000262 with the first term set to 1 and A084358 form a reciprocal pair under the list partition transform and associated operations described in A133314. Cf. A133289. - Tom Copeland, Oct 21 2007
Consider the distribution of n unlabeled elements "1" onto n levels where empty levels are allowed. In addition, the empty levels are labeled. Their names are 0_1, 0_2, 0_3, etc. This sequence gives the total number of such distributions. If the empty levels are unlabeled ("0"), then the answer is A001700. Let the colon ":" separate two levels. Then, for example, for n=3 we have a(3)=13 arrangements: 111:0_1:0_2, 0_1:111:0_2, 0_1:0_2:111, 111:0_2:0_1, 0_2:111:0_1, 0_2:0_1:111, 11:1:0, 11:0:1, 0:11:1, 1:11:0, 1:0:11, 0:1:11, 1:1:1. - Thomas Wieder, May 25 2008
Row sums of exponential Riordan array [1,x/(1-x)]. - Paul Barry, Jul 24 2008
a(n) is the number of partitions of [n] (A000110) into lists of noncrossing sets. For example, a(3)=3 counts 12, 1-2, 2-1 and a(4) = 73 counts the 75 partitions of [n] into lists of sets (A000670) except for 13-24, 24-13 which fail to be noncrossing. - David Callan, Jul 25 2008
a(i-j)/(i-j)! gives the value of the non-null element (i, j) of the lower triangular matrix exp(S)/exp(1), where S is the lower triangular matrix - of whatever dimension - having all its (non-null) elements equal to one. - Giuliano Cabrele, Aug 11 2008, Sep 07 2008
a(n) is also the number of nilpotent partial one-one bijections (of an n-element set). Equivalently, it is the number of nilpotents in the symmetric inverse semigroup (monoid). - Abdullahi Umar, Sep 14 2008
If n is a positive integer then the infinite continued fraction (1+n)/(1+(2+n)/(2+(3+n)/(3+...))) converges to the rational number A052852(n)/A000262(n). - David Angell (angell(AT)maths.unsw.edu.au), Dec 18 2008
Vladeta Jovovic's formula dated Sep 20 2006 can be restated as follows: a(n) is the n-th ascending factorial moment of the Poisson distribution with parameter (mean) 1. - Shai Covo (green355(AT)netvision.net.il), Jan 25 2010
The umbral exponential generating function for a(n) is (1-x)^{-B}. In other words, write (1-x)^{-B} as a power series in x whose coefficients are polynomials in B, and then replace B^k with the Bell number B_k. We obtain a(0) + a(1)x + a(2)x^2/2! + ... . - Richard Stanley, Jun 07 2010
a(n) is the number of Dyck n-paths (A000108) with its peaks labeled 1,2,...,k in some order, where k is the number of peaks. For example a(2)=3 counts U(1)DU(2)D, U(2)DU(1)D, UU(1)DD where the label at each peak is in parentheses. This is easy to prove using generating functions. - David Callan, Aug 23 2011
a(n) = number of permutations of the multiset {1,1,2,2,...,n,n} such that for 1 <= i <= n, all entries between the two i's exceed i and if any such entries are present, they include n. There are (2n-1)!! permutations satisfying the first condition, and for example: a(3)=13 counts all 5!!=15 of them except 331221 and 122133 which fail the second condition. - David Callan, Aug 27 2014_
a(n) is the number of acyclic, injective functions from subsets of [n] to [n]. Let subset D of [n] have size k. The number of acyclic, injective functions from D to [n] is (n-1)!/(n-k-1)! and hence a(n) = Sum_{k=0..n-1} binomial(n,k)*(n-1)!/(n-k-1)!. - Dennis P. Walsh, Nov 05 2015
a(n) is the number of acyclic, injective, labeled directed graphs on n vertices with each vertex having outdegree at most one. - Dennis P. Walsh, Nov 05 2015
For n > 0, a(n) is the number of labeled-rooted skinny-tree forests on n nodes. A skinny tree is a tree in which each vertex has at most one child. Let k denote the number of trees. There are binomial(n,k) ways to choose the roots, binomial(n-1,k-1) ways to choose the number of descendants for each root, and (n-k)! ways to permute those descendants. Summing over k, we obtain a(n) = Sum_{k=1..n} C(n,k)*C(n-1,k-1)*(n-k)!. - Dennis P. Walsh, Nov 10 2015
This is the Sheffer transform of the Bell numbers A000110 with the Sheffer matrix S = |Stirling1| = (1, -log(1-x)) = A132393. See the e.g.f. formula, a Feb 21 2017 comment on A048993, and R. Stanley's Jun 07 2010 comment above. - Wolfdieter Lang, Feb 21 2017
We conjecture that for k = 2,3,4,..., the difference a(n+k) - a(n) is divisible by k: if true, then for each k the sequence a(n) taken modulo k is periodic with period dividing k. - Peter Bala, Nov 14 2017
The above conjecture is true - see the Bala link. - Peter Bala, Jan 20 2018
The terms of this sequence can be derived from the numerators of the fractions, produced by the recursion: b(0) = 1, b(n) = 1 + ((n-1) * b(n-1)) / (n-1 + b(n-1)) for n > 0. The denominators give A002720. - Dimitris Valianatos, Aug 01 2018
a(n) is the number of rooted labeled forests on n nodes that avoid the patterns 213, 312, and 123. It is also the number of rooted labeled forests that avoid 312, 213, and 132, as well as the number of rooted labeled forests that avoid 132, 213, and 321. - Kassie Archer, Aug 30 2018
For n > 0, a(n) is the number of partitions of [2n-1] whose nontrivial blocks are of type {a,b}, with a <= n and b > n. In fact, for n > 0, a(n) = A056953(2n-1). - Francesca Aicardi, Nov 03 2022
For n > 0, a(n) is the number of ways to split n people into nonempty groups, have each group sit around a circular table, and select one person from each table (where two seating arrangements are considered identical if each person has the same left neighbors in both of them). - Enrique Navarrete, Oct 01 2023
|
|
REFERENCES
|
J. Riordan, Combinatorial Identities, Wiley, 1968, p. 194.
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
|
David Callan and Emeric Deutsch, The Run Transform, Discrete Math. 312 (2012), no. 19, 2927-2937, arXiv:1112.3639 [math.CO], 2011.
Salvador Jacobi, Planning in Multi-Agent Systems, Thesis, Technical University of Denmark, Department of Applied Mathematics and Computer Science, 2800 Kongens Lyngby, Denmark, 2014.
|
|
FORMULA
|
D-finite with recurrence: a(n) = (2*n-1)*a(n-1) - (n-1)*(n-2)*a(n-2).
E.g.f.: exp( x/(1-x) ).
a(n) = (n-1)!*LaguerreL(n-1,1,-1) for n >= 1. - Vladeta Jovovic, May 10 2003
Representation as n-th moment of a positive function on positive half-axis, in Maple notation: a(n) = integral(x^n*exp(-x-1)*BesselI(1, 2*x^(1/2))/x^(1/2), x =0..infinity), n=1, 2... - Karol A. Penson, Dec 04 2003
a(n) = n! Sum_{j=0..n-1} binomial(n-1, j)/(j+1)!, for n > 0. - Herbert S. Wilf, Jun 14 2005
Asymptotic expansion for large n: a(n) -> (0.4289*n^(-1/4) + 0.3574*n^(-3/4) - 0.2531*n^(-5/4) + O(n^(-7/4)))*(n^n)*exp(-n + 2*sqrt(n)). - Karol A. Penson, Aug 28 2002
Minor part of this asymptotic expansion is wrong! Right is (in closed form): a(n) ~ n^(n-1/4)*exp(-1/2+2*sqrt(n)-n)/sqrt(2) * (1 - 5/(48*sqrt(n)) - 95/(4608*n)), numerically a(n) ~ (0.42888194248*n^(-1/4) - 0.0446752023417*n^(-3/4) - 0.00884196713*n^(-5/4) + O(n^(-7/4))) *(n^n)*exp(-n+2*sqrt(n)). - Vaclav Kotesovec, Jun 02 2013
a(n) = exp(-1)*Sum_{m>=0} [m]^n/m!, where [m]^n = m*(m+1)*...*(m+n-1) is the rising factorial. - Vladeta Jovovic, Sep 20 2006
Recurrence: D(n,k) = D(n-1,k-1) + (n-1+k) * D(n-1,k) n >= k >= 0; D(n,0)=0. From this, D(n,1) = n! and D(n,n)=1; a(n) = Sum_{i=0..n} D(n,i). - Stephen Dalton (StephenMDalton(AT)gmail.com), Jan 05 2007
Proof: Notice two distinct subsets of the lists for [n]: 1) n is in its own list, then there are D(n-1,k-1); 2) n is in a list with other numbers. Denoting the separation of lists by |, it is not hard to see n has (n-1+k) possible positions, so (n-1+k) * D(n-1,k). - Stephen Dalton (StephenMDalton(AT)gmail.com), Jan 05 2007
Define f_1(x), f_2(x), ... such that f_1(x) = exp(x), f_{n+1}(x) = (d/dx)(x^2*f_n(x)), for n >= 2. Then a(n-1) = exp(-1)*f_n(1). - Milan Janjic, May 30 2008
a(n) = (n-1)! * Sum_{k=1..n} (a(n-k)*k!)/((n-k)!*(k-1)!), where a(0)=1. - Thomas Wieder, Sep 10 2008
a(n) = exp(-1)*n!*M(n+1,2,1), n >= 1, where M (=1F1) is the confluent hypergeometric function of the first kind. - Shai Covo (green355(AT)netvision.net.il), Jan 20 2010
From Sergei N. Gladkovskii, Nov 17 2011, Aug 02 2012, Dec 11 2012, Jan 27 2013, Jul 31 2013, Dec 25 2013: (Start)
Continued fractions:
E.g.f.: Q(0) where Q(k) = 1+x/((1-x)*(2k+1)-x*(1-x)*(2k+1)/(x+(1-x)*(2k+2)/Q(k+1))).
E.g.f.: 1 + x/(G(0)-x) where G(k) = (1-x)*k + 1 - x*(1-x)*(k+1)/G(k+1).
E.g.f.: exp(x/(1-x)) = 4/(2-(x/(1-x))*G(0))-1 where G(k) = 1 - x^2/(x^2 + 4*(1-x)^2*(2*k+1)*(2*k+3)/G(k+1) ).
E.g.f.: 1 + x*(E(0)-1)/(x+1) where E(k) = 1 + 1/(k+1)/(1-x)/(1-x/(x+1/E(k+1) )).
E.g.f.: E(0)/2, where E(k) = 1 + 1/(1 - x/(x + (k+1)*(1-x)/E(k+1) )).
E.g.f.: E(0)-1, where E(k) = 2 + x/( (2*k+1)*(1-x) - x/E(k+1) ).
(End)
E.g.f.: Product {n >= 1} ( (1 + x^n)/(1 - x^n) )^( phi(2*n)/(2*n) ), where phi(n) = A000010(n) is the Euler totient function. Cf. A088009. - Peter Bala, Jan 01 2014
a(n) = n!*hypergeom([1-n],[2],-1) for n >= 1. - Peter Luschny, Jun 05 2014
a(n) = (-1)^(n-1)*KummerU(1-n,2,-1). - Peter Luschny, Sep 17 2014
a(n) = hypergeom([-n+1, -n], [], 1) for n >= 0. - Peter Luschny, Apr 08 2015
0 = a(n)*(18*a(n+2) - 93*a(n+3) + 77*a(n+4) - 17*a(n+5) + a(n+6)) + a(n+1)*(9*a(n+2) - 80*a(n+3) + 51*a(n+4) - 6*a(n+5)) + a(n+2)*(3*a(n+2) - 34*a(n+3) + 15*a(n+4)) + a(n+3)*(-10*a(n+3)) if n >= 0. - Michael Somos, Feb 27 2017
G.f. G(x)=y satisfies a differential equation: (1-x)*y-2*(1-x)*x^2*y'+x^4*y''=1. - Bradley Klee, Aug 13 2018
a(n) = n! * LaguerreL(n, -1, -1) = c_{n}(n-1; -1) where c_{n}(x; a) are the Poisson - Charlier polynomials. - G. C. Greubel, Feb 23 2021
3 divides a(3*n-1); 9 divides a(9*n-1); 11 divides a(11*n-1). - Peter Bala, Mar 26 2022
For n > 0, a(n) = Sum_{k=0..n-1}*k!*C(n-1,k)*C(n,k). - Francesca Aicardi, Nov 03 2022
|
|
EXAMPLE
|
Illustration of first terms as sets of ordered lists of the first n integers:
a(1) = 1 : (1)
a(2) = 3 : (12), (21), (1)(2).
a(3) = 13 : (123) (6 ways), (12)(3) (2*3 ways) (1)(2)(3) (1 way)
a(4) = 73 : (1234) (24 ways), (123)(4) (6*4 ways), (12)(34) (2*2*3 ways), (12)(3)(4) (2*6 ways), (1)(2)(3)(4) (1 way).
:
G.f. = 1 + x + 3*x^2 + 13*x^3 + 73*x^4 + 501*x^4 + 4051*x^5 + 37633*x^6 + 394353*x^7 + ...
|
|
MAPLE
|
A000262 := proc(n) option remember: if n=0 then RETURN(1) fi: if n=1 then RETURN(1) fi: (2*n-1)*procname(n-1) - (n-1)*(n-2)*procname(n-2) end proc:
for n from 0 to 20 do printf(`%d, `, a(n)) od:
spec := [S, {S = Set(Prod(Z, Sequence(Z)))}, labeled]; [seq(combstruct[count](spec, size=n), n=0..40)];
with(combinat):seq(sum(abs(stirling1(n, k))*bell(k), k=0..n), n=0..18); # Zerinvary Lajos, Nov 26 2006
B:=[S, {S = Set(Sequence(Z, 1 <= card), card <=13)}, labelled]: seq(combstruct[count](B, size=n), n=0..19); # Zerinvary Lajos, Mar 21 2009
a := n -> `if`(n=0, 1, n!*hypergeom([1 - n], [2], -1)): seq(simplify(a(n)), n=0..19); # Peter Luschny, Jun 05 2014
|
|
MATHEMATICA
|
Range[0, 19]! CoefficientList[ Series[E^(x/(1-x)), {x, 0, 19}], x] (* Robert G. Wilson v, Apr 04 2005 *)
a[ n_]:= If[ n<0, 0, n! SeriesCoefficient[ Exp[x/(1-x)], {x, 0, n}]]; (* Michael Somos, Jul 19 2005 *)
a[n_]:=If[n==0, 1, n! Sum[Binomial[n-1, j]/(j+1)!, {j, 0, n-1}]]; Table[a[n], {n, 0, 30}] (* Wilf *)
a[0] = 1; a[n_]:= n!*Hypergeometric1F1[n+1, 2, 1]/E; Table[a[n], {n, 0, 19}] (* Jean-François Alcover, Jun 18 2012, after Shai Covo *)
a[ n_]:= If[ n<0, 0, n! SeriesCoefficient[ Product[ QPochhammer[x^k]^(-MoebiusMu[k]/k), {k, n}], {x, 0, n}]]; (* Michael Somos, Jun 02 2019 *)
Table[n!*LaguerreL[n, -1, -1], {n, 0, 30}] (* G. C. Greubel, Feb 23 2021 *)
RecurrenceTable[{a[n] == (2*n - 1)*a[n-1] - (n-1)*(n-2)*a[n-2], a[0] == 1, a[1] == 1}, a, {n, 0, 30}] (* Vaclav Kotesovec, Jul 21 2022 *)
|
|
PROG
|
(PARI) {a(n) = if( n<0, 0, n! * polcoeff( exp( x / (1 - x) + x * O(x^n)), n))}; /* Michael Somos, Feb 10 2005 */
(PARI) {a(n) = if( n<0, 0, n! * polcoeff( prod( k=1, n, eta(x^k + x * O(x^n))^( -moebius(k) / k)), n))}; /* Michael Somos, Feb 10 2005 */
(PARI) {a(n) = s = 1; for(k = 1, n-1, s = 1 + k * s / (k + s)); return( numerator(s))}; /* Dimitris Valianatos, Aug 03 2018 */
(PARI) {a(n) = if( n<0, 0, n! * polcoeff( prod( k=1, n, (1 - x^k + x * O(x^n))^(-eulerphi(k) / k)), n))}; /* Michael Somos, Jun 02 2019 */
(PARI) a(n) = if (n==0, 1, (n-1)!*pollaguerre(n-1, 1, -1)); \\ Michel Marcus, Feb 23 2021; Jul 13 2024
(Maxima) makelist(sum(abs(stirling1(n, k))*belln(k), k, 0, n), n, 0, 24); /* Emanuele Munarini, Jul 04 2011 */
(Maxima) makelist(hypergeometric([-n+1, -n], [], 1), n, 0, 12); /* Emanuele Munarini, Sep 27 2016 */
(Haskell)
a000262 n = a000262_list !! n
a000262_list = 1 : 1 : zipWith (-)
(tail $ zipWith (*) a005408_list a000262_list)
(zipWith (*) a002378_list a000262_list)
(Sage)
A000262 = lambda n: hypergeometric([-n+1, -n], [], 1)
(GAP)
a:=[1, 1];; for n in [3..10^2] do a[n]:=(2*n-3)*a[n-1]-(n-2)*(n-3)*a[n-2]; od; A000262:=a; # Muniru A Asiru, Oct 01 2017
(Magma) I:=[1, 3]; [1] cat [n le 2 select I[n] else (2*n-1)*Self(n-1) - (n-1)*(n-2)*Self(n-2): n in [1..30]]; // Vincenzo Librandi, Jun 14 2019
(Magma) [Factorial(n)*Evaluate(LaguerrePolynomial(n, -1), -1): n in [0..30]]; // G. C. Greubel, Feb 23 2021
(Python)
from sympy import hyper, hyperexpand
|
|
CROSSREFS
|
|
|
KEYWORD
|
nonn,easy,core,nice
|
|
AUTHOR
|
|
|
STATUS
|
approved
|
|
|
|