[go: up one dir, main page]

login
Search: a008615 -id:a008615
     Sort: relevance | references | number | modified | created      Format: long | short | data
Triangle of coefficients of Chebyshev's S(n,x) := U(n,x/2) polynomials (exponents in increasing order).
+10
490
1, 0, 1, -1, 0, 1, 0, -2, 0, 1, 1, 0, -3, 0, 1, 0, 3, 0, -4, 0, 1, -1, 0, 6, 0, -5, 0, 1, 0, -4, 0, 10, 0, -6, 0, 1, 1, 0, -10, 0, 15, 0, -7, 0, 1, 0, 5, 0, -20, 0, 21, 0, -8, 0, 1, -1, 0, 15, 0, -35, 0, 28, 0, -9, 0, 1, 0, -6, 0, 35, 0, -56, 0, 36, 0, -10, 0, 1, 1, 0, -21, 0, 70, 0, -84, 0
OFFSET
0,8
COMMENTS
G.f. for row polynomials S(n,x) (signed triangle): 1/(1-x*z+z^2). Unsigned triangle |a(n,m)| has Fibonacci polynomials F(n+1,x) as row polynomials with g.f. 1/(1-x*z-z^2). |a(n,m)| triangle has rows of Pascal's triangle A007318 in the even-numbered diagonals (odd-numbered ones have only 0's).
Row sums (unsigned triangle) A000045(n+1) (Fibonacci). Row sums (signed triangle) S(n,1) sequence = periodic(1,1,0,-1,-1,0) = A010892.
Alternating row sums A049347(n) = S(n,-1) = periodic(1,-1,0). - Wolfdieter Lang, Nov 04 2011
S(n,x) is the characteristic polynomial of the adjacency matrix of the n-path. - Michael Somos, Jun 24 2002
S(n,x) is also the matching polynomial of the n-path. - Eric W. Weisstein, Apr 10 2017
|T(n,k)| = number of compositions of n+1 into k+1 odd parts. Example: |T(7,3)| = 10 because we have (1,1,3,3), (1,3,1,3), (1,3,3,1), (3,1,1,3), (3,1,3,1), (3,3,1,1), (1,1,1,5), (1,1,5,1), (1,5,1,1) and (5,1,1,1). - Emeric Deutsch, Apr 09 2005
S(n,x)= R(n,x) + S(n-2,x), n >= 2, S(-1,x)=0, S(0,x)=1, R(n,x):=2*T(n,x/2) = Sum_{m=0..n} A127672(n,m)*x^m (monic integer Chebyshev T-Polynomials). This is the rewritten so-called trace of the transfer matrix formula for the T-polynomials. - Wolfdieter Lang, Dec 02 2010
In a regular N-gon inscribed in a unit circle, the side length is d(N,1) = 2*sin(Pi/N). The length ratio R(N,k):=d(N,k)/d(N,1) for the (k-1)-th diagonal, with k from {2,3,...,floor(N/2)}, N >= 4, equals S(k-1,x) = sin(k*Pi/N)/sin(Pi/N) with x=rho(N):=R(N,2) = 2*cos(Pi/N). Example: N=7 (heptagon), rho=R(7,2), sigma:=R(N,3) = S(2,rho) = rho^2 - 1. Motivated by the quoted paper by P. Steinbach. - Wolfdieter Lang, Dec 02 2010
From Wolfdieter Lang, Jul 12 2011: (Start)
In q- or basic analysis, q-numbers are [n]_q :=S(n-1,q+1/q) = (q^n-(1/q)^n})/(q-1/q), with the row polynomials S(n,x), n >= 0.
The zeros of the row polynomials S(n-1,x) are (from those of Chebyshev U-polynomials):
x(n-1;k) = +- t(k,rho(n)), k = 1..ceiling((n-1)/2), n >= 2, with t(n,x) the row polynomials of A127672 and rho(n):= 2*cos(Pi/n). The simple vanishing zero for even n appears here as +0 and -0.
Factorization of the row polynomials S(n-1,x), x >= 1, in terms of the minimal polynomials of cos(2 Pi/2), called Psi(n,x), with coefficients given by A181875/A181876:
S(n-1,x) = (2^(n-1))*Product_{n>=1}(Psi(d,x/2), 2 < d | 2n).
(From the rewritten eq. (3) of the Watkins and Zeitlin reference, given under A181872.) [See the W. Lang ArXiv link, Proposition 9, eq. (62). - Wolfdieter Lang, Apr 14 2018]
(End)
The discriminants of the S(n,x) polynomials are found in A127670. - Wolfdieter Lang, Aug 03 2011
This is an example for a subclass of Riordan convolution arrays (lower triangular matrices) called Bell arrays. See the L. W. Shapiro et al. reference under A007318. If a Riordan array is named (G(z),F(z)) with F(z)=z*Fhat(z), the o.g.f. for the row polynomials is G(z)/(1-x*z*Fhat(z)), and it becomes a Bell array if G(z)=Fhat(z). For the present Bell type triangle G(z)=1/(1+z^2) (see the o.g.f. comment above). This leads to the o.g.f. for the column no. k, k >= 0, x^k/(1+x^2)^(k+1) (see the formula section), the one for the row sums and for the alternating row sums (see comments above). The Riordan (Bell) A- and Z-sequences (defined in a W. Lang link under A006232, with references) have o.g.f.s 1-x*c(x^2) and -x*c(x^2), with the o.g.f. of the Catalan numbers A000108. Together they lead to a recurrence given in the formula section. - Wolfdieter Lang, Nov 04 2011
The determinant of the N x N matrix S(N,[x[1], ..., x[N]]) with elements S(m-1,x[n]), for n, m = 1, 2, ..., N, and for any x[n], is identical with the determinant of V(N,[x[1], ..., x[N]]) with elements x[n]^(m-1) (a Vandermondian, which equals Product_{1 <= i < j<= N} (x[j] - x[i])). This is a special instance of a theorem valid for any N >= 1 and any monic polynomial system p(m,x), m>=0, with p(0,x) = 1. For this theorem see the Vein-Dale reference, p. 59. Thanks to L. Edson Jeffery for an email asking for a proof of the non-singularity of the matrix S(N,[x[1], ...., x[N]]) if and only if the x[j], j = 1..N, are pairwise distinct. - Wolfdieter Lang, Aug 26 2013
These S polynomials also appear in the context of modular forms. The rescaled Hecke operator T*_n = n^((1-k)/2)*T_n acting on modular forms of weight k satisfies T*_(p^n) = S(n, T*_p), for each prime p and positive integer n. See the Koecher-Krieg reference, p. 223. - Wolfdieter Lang, Jan 22 2016
For a shifted o.g.f. (mod signs), its compositional inverse, and connections to Motzkin and Fibonacci polynomials, non-crossing partitions and other combinatorial structures, see A097610. - Tom Copeland, Jan 23 2016
From M. Sinan Kul, Jan 30 2016; edited by Wolfdieter Lang, Jan 31 2016 and Feb 01 2016: (Start)
Solutions of the Diophantine equation u^2 + v^2 - k*u*v = 1 for integer k given by (u(k,n), v(k,n)) = (S(n,k), S(n-1,k)) because of the Cassini-Simson identity: S(n,x)^2 - S(n+1,x)*S(n-1, x) = 1, after use of the S-recurrence. Note that S(-n, x) = -S(-n-2, x), n >= 1, and the periodicity of some S(n, k) sequences.
Hence another way to obtain the row polynomials would be to take powers of the matrix [x, -1; 1,0]: S(n, x) = (([x, -1; 1, 0])^n)[1,1], n >= 0.
See also a Feb 01 2016 comment on A115139 for a well-known S(n, x) sum formula.
Then we have with the present T triangle
A039834(n) = -i^(n+1)*T(n-1, k) where i is the imaginary unit and n >= 0.
A051286(n) = Sum_{i=0..n} T(n,i)^2 (see the Philippe Deléham, Nov 21 2005 formula),
A181545(n) = Sum_{i=0..n+1} abs(T(n,i)^3),
A181546(n) = Sum_{i=0..n+1} T(n,i)^4,
A181547(n) = Sum_{i=0..n+1} abs(T(n,i)^5).
S(n, 0) = A056594(n), and for k = 1..10 the sequences S(n-1, k) with offset n = 0 are A128834, A001477, A001906, A001353, A004254, A001109, A004187, A001090, A018913, A004189.
(End)
For more on the Diophantine equation presented by Kul, see the Ismail paper. - Tom Copeland, Jan 31 2016
The o.g.f. for the Legendre polynomials L(n,x) is 1 / sqrt(1- 2x*z + z^2), and squaring it gives the o.g.f. of U(n,x), A053117, so Sum_{k=0..n} L(k,x/2) L(n-k,x/2) = S(n,x). This gives S(n,x) = L(n/2,x/2)^2 + 2*Sum_{k=0..n/2-1} L(k,x/2) L(n-k,x/2) for n even and S(n,x) = 2*Sum_{k=0..(n-1)/2} L(k,x/2) L(n-k,x/2) for odd n. For a connection to elliptic curves and modular forms, see A053117. For the normalized Legendre polynomials, see A100258. For other properties and relations to other polynomials, see Allouche et al. - Tom Copeland, Feb 04 2016
LG(x,h1,h2) = -log(1 - h1*x + h2*x^2) = Sum_{n>0} F(n,-h1,h2,0,..,0) x^n/n is a log series generator of the bivariate row polynomials of A127672 with A127672(0,0) = 0 and where F(n,b1,b2,..,bn) are the Faber polynomials of A263916. Exp(LG(x,h1,h2)) = 1 / (1 - h1*x + h2*x^2 ) is the o.g.f. of the bivariate row polynomials of this entry. - Tom Copeland, Feb 15 2016 (Instances of the bivariate o.g.f. for this entry are on pp. 5 and 18 of Sunada. - Tom Copeland, Jan 18 2021)
For distinct odd primes p and q the Legendre symbol can be written as Legendre(q,p) = Product_{k=1..P} S(q-1, 2*cos(2*Pi*k/p)), with P = (p-1)/2. See the Lemmermeyer reference, eq. (8.1) on p. 236. Using the zeros of S(q-1, x) (see above) one has S(q-1, x) = Product_{l=1..Q} (x^2 - (2*cos(Pi*l/q))^2), with Q = (q-1)/2. Thus S(q-1, 2*cos(2*Pi*k/p)) = ((-4)^Q)*Product_{l=1..Q} (sin^2(2*Pi*k/p) - sin^2(Pi*l/q)) = ((-4)^Q)*Product_{m=1..Q} (sin^2(2*Pi*k/p) - sin^2(2*Pi*m/q)). For the proof of the last equality see a W. Lang comment on the triangle A057059 for n = Q and an obvious function f. This leads to Eisenstein's proof of the quadratic reciprocity law Legendre(q,p) = ((-1)^(P*Q)) * Legendre(p,q), See the Lemmermeyer reference, pp. 236-237. - Wolfdieter Lang, Aug 28 2016
For connections to generalized Fibonacci polynomials, compare their generating function on p. 5 of the Amdeberhan et al. link with the o.g.f. given above for the bivariate row polynomials of this entry. - Tom Copeland, Jan 08 2017
The formula for Ramanujan's tau function (see A000594) for prime powers is tau(p^k) = p^(11*k/2)*S(k, p^(-11/2)*tau(p)) for k >= 1, and p = A000040(n), n >= 1. See the Hardy reference, p. 164, eqs. (10.3.4) and (10.3.6) rewritten in terms of S. - Wolfdieter Lang, Jan 27 2017
From Wolfdieter Lang, May 08 2017: (Start)
The number of zeros Z(n) of the S(n, x) polynomials in the open interval (-1,+1) is 2*b(n) for even n >= 0 and 1 + 2*b(n) for odd n >= 1, where b(n) = floor(n/2) - floor((n+1)/3). This b(n) is the number of integers k in the interval (n+1)/3 < k <= floor(n/2). See a comment on the zeros of S(n, x) above, and b(n) = A008615(n-2), n >= 0. The numbers Z(n) have been proposed (with a conjecture related to A008611) by Michel Lagneau, Mar 2017, as the number of zeros of Fibonacci polynomials on the imaginary axis (-I,+I), with I=sqrt(-1). They are Z(n) = A008611(n-1), n >= 0, with A008611(-1) = 0. Also Z(n) = A194960(n-4), n >= 0. Proof using the A008611 version. A194960 follows from this.
In general the number of zeros Z(a;n) of S(n, x) for n >= 0 in the open interval (-a,+a) for a from the interval (0,2) (x >= 2 never has zeros, and a=0 is trivial: Z(0;n) = 0) is with b(a;n) = floor(n//2) - floor((n+1)*arccos(a/2)/Pi), as above Z(a;n) = 2*b(a;n) for even n >= 0 and 1 + 2*b(a;n) for odd n >= 1. For the closed interval [-a,+a] Z(0;n) = 1 and for a from (0,1) one uses for Z(a;n) the values b(a;n) = floor(n/2) - ceiling((n+1)*arccos(a/2)/Pi) + 1. (End)
The Riordan row polynomials S(n, x) (Chebyshev S) belong to the Boas-Buck class (see a comment and references in A046521), hence they satisfy the Boas-Buck identity: (E_x - n*1)*S(n, x) = (E_x + 1)*Sum_{p=0..n-1} (1 - (-1)^p)*(-1)^((p+1)/2)*S(n-1-p, x), for n >= 0, where E_x = x*d/dx (Euler operator). For the triangle T(n, k) this entails a recurrence for the sequence of column k, given in the formula section. - Wolfdieter Lang, Aug 11 2017
The e.g.f. E(x,t) := Sum_{n>=0} (t^n/n!)*S(n,x) for the row polynomials is obtained via inverse Laplace transformation from the above given o.g.f. as E(x,t) = ((1/xm)*exp(t/xm) - (1/xp)*exp(t/xp) )/(xp - xm) with xp = (x + sqrt(x^2-4))/2 and xm = (x - sqrt(x^2-4))/2. - Wolfdieter Lang, Nov 08 2017
From Wolfdieter Lang, Apr 12 2018: (Start)
Factorization of row polynomials S(n, x), for n >= 1, in terms of C polynomials (not Chebyshev C) with coefficients given in A187360. This is obtained from the factorization into Psi polynomials (see the Jul 12 2011 comment above) but written in terms of minimal polynomials of 2*cos(2*Pi/n) with coefficients in A232624:
S(2*k, x) = Product_{2 <= d | (2*k+1)} C(d, x)*(-1)^deg(d)*C(d, -x), with deg(d) = A055034(d) the degree of C(d, x).
S(2*k+1, x) = Product_{2 <= d | 2*(k+1)} C(d, x) * Product_{3 <= 2*d + 1 | (k+1)} (-1)^(deg(2*d+1))*C(2*d+1, -x).
Note that (-1)^(deg(2*d+1))*C(2*d+1, -x)*C(2*d+1, x) pairs always appear.
The number of C factors of S(2*k, x), for k >= 0, is 2*(tau(2*k+1) - 1) = 2*(A099774(k+1) - 1) = 2*A095374(k), and for S(2*k+1, x), for k >= 0, it is tau(2*(k+1)) + tau_{odd}(k+1) - 2 = A302707(k), with tau(2*k+1) = A099774(k+1), tau(n) = A000005 and tau(2*(k+1)) = A099777(k+1).
For the reverse problem, the factorization of C polynomials into S polynomials, see A255237. (End)
The S polynomials with general initial conditions S(a,b;n,x) = x*S(a,b;n-1,x) - S(a,b;n-2,x), for n >= 1, with S(a,b;-1,x) = a and S(a,b;0,x) = b are S(a,b;n,x) = b*S(n, x) - a*S(n-1, x), for n >= -1. Recall that S(-2, x) = -1 and S(-1, x) = 0. The o.g.f. is G(a,b;z,x) = (b - a*z)/(1 - x*z + z^2). - Wolfdieter Lang, Oct 18 2019
Also the convolution triangle of A101455. - Peter Luschny, Oct 06 2022
From Wolfdieter Lang, Apr 26 2023: (Start)
Multi-section of S-polynomials: S(m*n+k, x) = S(m+k, x)*S(n-1, R(m, x)) - S(k, x)*S(n-2, R(m, x)), with R(n, x) = S(n, x) - S(n-2, x) (see A127672), S(-2, x) = -1, and S(-1, x) = 0, for n >= 0, m >= 1, and k = 0, 1, ..., m-1.
O.g.f. of {S(m*n+k, y)}_{n>=0}: G(m,k,y,x) = (S(k, y) - (S(k, y)*R(m, y) - S(m+k, y))*x)/(1 - R(m,y)*x + x^2).
See eqs. (40) and (49), with r = x or y and s =-1, of the G. Detlefs and W. Lang link at A034807. (End)
S(n, x) for complex n and complex x: S(n, x) = ((-i/2)/sqrt(1 - (x/2)^2))*(q(x/2)*exp(+n*log(q(x/2))) - (1/q(x/2))*exp(-n*log(q(x/2)))), with q(x) = x + sqrt(1 - x^2)*i. Here log(z) = |z| + Arg(z)*i, with Arg(z) from [-Pi,+Pi) (principal branch). This satisfies the recurrence relation for S because it is derived from the Binet - de Moivre formula for S. Examples: S(n/m, 0) = cos((n/m)*Pi/4), for n >= 0 and m >= 1. S(n*i, 0) = (1/2)*(1 + exp(n*Pi))*exp(-(n/2)*Pi), for n >= 0. S(1+i, 2+i) = 0.6397424847... + 1.0355669490...*i. Thanks to Roberto Alfano for asking a question leading to this formula. - Wolfdieter Lang, Jun 05 2023
Lim_{n->oo} S(n, x)/S(n-1, x) = r(x) = (x - sqrt(x^2 -4))/2, for |x| >= 2. For x = +-2, this limit is +-1. - Wolfdieter Lang, Nov 15 2023
REFERENCES
G. H. Hardy, Ramanujan: twelve lectures on subjects suggested by his life and work, AMS Chelsea Publishing, Providence, Rhode Island, 2002, p. 164.
Max Koecher and Aloys Krieg, Elliptische Funktionen und Modulformen, 2. Auflage, Springer, 2007, p. 223.
Franz Lemmermeyer, Reciprocity Laws. From Euler to Eisenstein, Springer, 2000.
D. S. Mitrinovic, Analytic Inequalities, Springer-Verlag, 1970; p. 232, Sect. 3.3.38.
Theodore J. Rivlin, Chebyshev polynomials: from approximation theory to algebra and number theory, 2. ed., Wiley, New York, 1990, pp. 60 - 61.
R. Vein and P. Dale, Determinants and Their Applications in Mathematical Physics, Springer, 1999.
LINKS
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], Table 22.8, p.797.
J. Allouche and G. Skordev, Schur congruences, Carlitz sequences of polynomials and automaticity, Discrete Mathematics, Vol. 214, Issue 1-3, 21 March 2000, p.21-49.
T. Amdeberhan, X. Chen, V. Moll, and B. Sagan, Generalized Fibonacci polynomials and Fibonomial coefficients, arXiv preprint arXiv:1306.6511 [math.CO], 2013.
Paul Barry, On the inversion of Riordan arrays, arXiv:2101.06713 [math.CO], 2021.
Paul Barry and A. Hennessy, Meixner-Type Results for Riordan Arrays and Associated Integer Sequences, J. Int. Seq. 13 (2010) # 10.9.4, section 5.
C. Beck, Spatio-temporal Chaos and Vacuum Fluctuations of Quantized Fields , arXiv preprint arXiv:0207081 [hep-th], 2002.
Alexander Burstein and Louis W. Shapiro, Pseudo-involutions in the Riordan group, arXiv:2112.11595 [math.CO], 2021.
S. R. Finch, P. Sebah and Z.-Q. Bai, Odd Entries in Pascal's Trinomial Triangle, arXiv:0802.2654 [math.NT], 2008.
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.
M. Ismail, One parameter generalizations of the Fibonacci and Lucas numbers, arXiv preprint arXiv:0606743v1 [math.CA], 2006.
Wolfdieter Lang, The field Q(2cos(pi/n)), its Galois group and length ratios in the regular n-gon, arXiv:1210.1018 [math.GR], 2012-2017.
R. Sazdanovic, A categorification of the polynomial ring, slide presentation, 2011. [From Tom Copeland, Dec 27 2015]
P. Steinbach, Golden fields: a case for the heptagon, Math. Mag. 70 (1997), no. 1, 22-31.
T. Sunada, Discrete Geometric Analysis, 2008.
FORMULA
T(n,k) := 0 if n < k or n+k odd, otherwise ((-1)^((n+k)/2+k))*binomial((n+k)/2, k); T(n, k) = -T(n-2, k)+T(n-1, k-1), T(n, -1) := 0 =: T(-1, k), T(0, 0)=1, T(n, k)= 0 if n < k or n+k odd; g.f. k-th column: (1 / (1 + x^2)^(k + 1)) * x^k. - Michael Somos, Jun 24 2002
T(n,k) = binomial((n+k)/2, (n-k)/2)*cos(Pi*(n-k)/2)*(1+(-1)^(n-k))/2. - Paul Barry, Aug 28 2005
Sum_{k=0..n} T(n,k)^2 = A051286(n). - Philippe Deléham, Nov 21 2005
Recurrence for the (unsigned) Fibonacci polynomials: F(1)=1, F(2)=x; for n > 2, F(n) = x*F(n-1) + F(n-2).
From Wolfdieter Lang, Nov 04 2011: (Start)
The Riordan A- and Z-sequences, given in a comment above, lead together to the recurrence:
T(n,k) = 0 if n < k, if k=0 then T(0,0)=1 and
T(n,0)= -Sum_{i=0..floor((n-1)/2)} C(i)*T(n-1,2*i+1), otherwise T(n,k) = T(n-1,k-1) - Sum_{i=1..floor((n-k)/2)} C(i)*T(n-1,k-1+2*i), with the Catalan numbers C(n)=A000108(n).
(End)
The row polynomials satisfy also S(n,x) = 2*(T(n+2, x/2) - T(n, x/2))/(x^2-4) with the Chebyshev T-polynomials. Proof: Use the trace formula 2*T(n, x/2) = S(n, x) - S(n-2, x) (see the Dec 02 2010 comment above) and the S-recurrence several times. This is a formula which expresses the S- in terms of the T-polynomials. - Wolfdieter Lang, Aug 07 2014
From Tom Copeland, Dec 06 2015: (Start)
The non-vanishing, unsigned subdiagonals Diag_(2n) contain the elements D(n,k) = Sum_{j=0..k} D(n-1,j) = (k+1) (k+2) ... (k+n) / n! = binomial(n+k,n), so the o.g.f. for the subdiagonal is (1-x)^(-(n+1)). E.g., Diag_4 contains D(2,3) = D(1,0) + D(1,1) + D(1,2) + D(1,3) = 1 + 2 + 3 + 4 = 10 = binomial(5,2). Diag_4 is shifted A000217; Diag_6, shifted A000292: Diag_8, shifted A000332; and Diag_10, A000389.
The non-vanishing antidiagonals are signed rows of the Pascal triangle A007318.
For a reversed, unsigned version with the zeros removed, see A011973. (End)
The Boas-Buck recurrence (see a comment above) for the sequence of column k is: S(n, k) = ((k+1)/(n-k))*Sum_{p=0..n-1-k} (1 - (-1)^p)*(-1)^((p+1)/2) * S(n-1-p, k), for n > k >= 0 and input S(k, k) = 1. - Wolfdieter Lang, Aug 11 2017
The m-th row consecutive nonzero entries in order are (-1)^c*(c+b)!/c!b! with c = m/2, m/2-1, ..., 0 and b = m-2c if m is even and with c = (m-1)/2, (m-1)/2-1, ..., 0 with b = m-2c if m is odd. For the 8th row starting at a(36) the 5 consecutive nonzero entries in order are 1,-10,15,-7,1 given by c = 4,3,2,1,0 and b = 0,2,4,6,8. - Richard Turk, Aug 20 2017
O.g.f.: exp( Sum_{n >= 0} 2*T(n,x/2)*t^n/n ) = 1 + x*t + (-1 + x^2)*t^2 + (-2*x + x^3)*t^3 + (1 - 3*x^2 + x^4)*t^4 + ..., where T(n,x) denotes the n-th Chebyshev polynomial of the first kind. - Peter Bala, Aug 15 2022
EXAMPLE
The triangle T(n, k) begins
n\k 0 1 2 3 4 5 6 7 8 9 10 11
0: 1
1: 0 1
2: -1 0 1
3: 0 -2 0 1
4: 1 0 -3 0 1
5: 0 3 0 -4 0 1
6: -1 0 6 0 -5 0 1
7: 0 -4 0 10 0 -6 0 1
8: 1 0 -10 0 15 0 -7 0 1
9: 0 5 0 -20 0 21 0 -8 0 1
10: -1 0 15 0 -35 0 28 0 -9 0 1
11: 0 -6 0 35 0 -56 0 36 0 -10 0 1
... Reformatted and extended by Wolfdieter Lang, Oct 24 2012
For more rows see the link.
E.g., fourth row {0,-2,0,1} corresponds to polynomial S(3,x)= -2*x + x^3.
From Wolfdieter Lang, Jul 12 2011: (Start)
Zeros of S(3,x) with rho(4)= 2*cos(Pi/4) = sqrt(2):
+- t(1,sqrt(2)) = +- sqrt(2) and
+- t(2,sqrt(2)) = +- 0.
Factorization of S(3,x) in terms of Psi polynomials:
S(3,x) = (2^3)*Psi(4,x/2)*Psi(8,x/2) = x*(x^2-2).
(End)
From Wolfdieter Lang, Nov 04 2011: (Start)
A- and Z- sequence recurrence:
T(4,0) = - (C(0)*T(3,1) + C(1)*T(3,3)) = -(-2 + 1) = +1,
T(5,3) = -3 - 1*1 = -4.
(End)
Boas-Buck recurrence for column k = 2, n = 6: S(6, 2) = (3/4)*(0 - 2* S(4 ,2) + 0 + 2*S(2, 2)) = (3/4)*(-2*(-3) + 2) = 6. - Wolfdieter Lang, Aug 11 2017
From Wolfdieter Lang, Apr 12 2018: (Start)
Factorization into C polynomials (see the Apr 12 2018 comment):
S(4, x) = 1 - 3*x^2 + x^4 = (-1 + x + x^2)*(-1 - x + x^2) = (-C(5, -x)) * C(5, x); the number of factors is 2 = 2*A095374(2).
S(5, x) = 3*x - 4*x^3 + x^5 = x*(-1 + x)*(1 + x)*(-3 + x^2) = C(2, x)*C(3, x)*(-C(3, -x))*C(6, x); the number of factors is 4 = A302707(2). (End)
MAPLE
A049310 := proc(n, k): binomial((n+k)/2, (n-k)/2)*cos(Pi*(n-k)/2)*(1+(-1)^(n-k))/2 end: seq(seq(A049310(n, k), k=0..n), n=0..11); # Johannes W. Meijer, Aug 08 2011
# Uses function PMatrix from A357368. Adds a row above and a column to the left.
PMatrix(10, n -> ifelse(irem(n, 2) = 0, 0, (-1)^iquo(n-1, 2))); # Peter Luschny, Oct 06 2022
MATHEMATICA
t[n_, k_] /; EvenQ[n+k] = ((-1)^((n+k)/2+k))*Binomial[(n+k)/2, k]; t[n_, k_] /; OddQ[n+k] = 0; Flatten[Table[t[n, k], {n, 0, 12}, {k, 0, n}]][[;; 86]] (* Jean-François Alcover, Jul 05 2011 *)
Table[Coefficient[(-I)^n Fibonacci[n + 1, - I x], x, k], {n, 0, 10}, {k, 0, n}] //Flatten (* Clark Kimberling, Aug 02 2011; corrected by Eric W. Weisstein, Apr 06 2017 *)
CoefficientList[ChebyshevU[Range[0, 10], -x/2], x] // Flatten (* Eric W. Weisstein, Apr 06 2017 *)
CoefficientList[Table[(-I)^n Fibonacci[n + 1, -I x], {n, 0, 10}], x] // Flatten (* Eric W. Weisstein, Apr 06 2017 *)
PROG
(PARI) {T(n, k) = if( k<0 || k>n || (n + k)%2, 0, (-1)^((n + k)/2 + k) * binomial((n + k)/2, k))} /* Michael Somos, Jun 24 2002 */
(SageMath)
@CachedFunction
def A049310(n, k):
if n< 0: return 0
if n==0: return 1 if k == 0 else 0
return A049310(n-1, k-1) - A049310(n-2, k)
for n in (0..9): [A049310(n, k) for k in (0..n)] # Peter Luschny, Nov 20 2012
(Magma)
A049310:= func< n, k | ((n+k) mod 2) eq 0 select (-1)^(Floor((n+k)/2)+k)*Binomial(Floor((n+k)/2), k) else 0 >;
[A049310(n, k): k in [0..n], n in [0..15]]; // G. C. Greubel, Jul 25 2022
CROSSREFS
Cf. A000005, A000217, A000292, A000332, A000389, A001227, A007318, A008611, A008615, A101455, A010892, A011973, A053112 (without zeros), A053117, A053119 (reflection), A053121 (inverse triangle), A055034, A097610, A099774, A099777, A100258, A112552 (first column clipped), A127672, A168561 (absolute values), A187360. A194960, A232624, A255237.
Triangles of coefficients of Chebyshev's S(n,x+k) for k = 5, 4, 3, 2, 1, 0, -1, -2, -3, -4, -5: A207824, A207823, A125662, A078812, A101950, A049310, A104562, A053122, A207815, A159764, A123967.
KEYWORD
easy,nice,sign,tabl,core
STATUS
approved
Nonnegative integers repeated, floor(n/2).
+10
476
0, 0, 1, 1, 2, 2, 3, 3, 4, 4, 5, 5, 6, 6, 7, 7, 8, 8, 9, 9, 10, 10, 11, 11, 12, 12, 13, 13, 14, 14, 15, 15, 16, 16, 17, 17, 18, 18, 19, 19, 20, 20, 21, 21, 22, 22, 23, 23, 24, 24, 25, 25, 26, 26, 27, 27, 28, 28, 29, 29, 30, 30, 31, 31, 32, 32, 33, 33, 34, 34, 35, 35, 36, 36
OFFSET
0,5
COMMENTS
Number of elements in the set {k: 1 <= 2k <= n}.
Dimension of the space of weight 2n+4 cusp forms for Gamma_0(2).
Dimension of the space of weight 1 modular forms for Gamma_1(n+1).
Number of ways 2^n is expressible as r^2 - s^2 with s > 0. Proof: (r+s) and (r-s) both should be powers of 2, even and distinct hence a(2k) = a(2k-1) = (k-1) etc. - Amarnath Murthy, Sep 20 2002
Lengths of sides of Ulam square spiral; i.e., lengths of runs of equal terms in A063826. - Donald S. McDonald, Jan 09 2003
Number of partitions of n into two parts. A008619 gives partitions of n into at most two parts, so A008619(n) = a(n) + 1 for all n >= 0. Partial sums are A002620 (Quarter-squares). - Rick L. Shepherd, Feb 27 2004
a(n+1) is the number of 1's in the binary expansion of the Jacobsthal number A001045(n). - Paul Barry, Jan 13 2005
Number of partitions of n+1 into two distinct (nonzero) parts. Example: a(8) = 4 because we have [8,1],[7,2],[6,3] and [5,4]. - Emeric Deutsch, Apr 14 2006
Complement of A000035, since A000035(n)+2*a(n) = n. Also equal to the partial sums of A000035. - Hieronymus Fischer, Jun 01 2007
Number of binary bracelets of n beads, two of them 0. For n >= 2, a(n-2) is the number of binary bracelets of n beads, two of them 0, with 00 prohibited. - Washington Bomfim, Aug 27 2008
Let A be the Hessenberg n X n matrix defined by: A[1,j] = j mod 2, A[i,i]:=1, A[i,i-1] = -1, and A[i,j] = 0 otherwise. Then, for n >= 1, a(n+1) = (-1)^n det(A). - Milan Janjic, Jan 24 2010
From Clark Kimberling, Mar 10 2011: (Start)
Let RT abbreviate rank transform (A187224). Then
RT(this sequence) = A187484;
RT(this sequence without 1st term) = A026371;
RT(this sequence without 1st 2 terms) = A026367;
RT(this sequence without 1st 3 terms) = A026363. (End)
The diameter (longest path) of the n-cycle. - Cade Herron, Apr 14 2011
For n >= 3, a(n-1) is the number of two-color bracelets of n beads, three of them are black, having a diameter of symmetry. - Vladimir Shevelev, May 03 2011
Pelesko (2004) refers erroneously to this sequence instead of A008619. - M. F. Hasler, Jul 19 2012
Number of degree 2 irreducible characters of the dihedral group of order 2(n+1). - Eric M. Schmidt, Feb 12 2013
For n >= 3 the sequence a(n-1) is the number of non-congruent regions with infinite area in the exterior of a regular n-gon with all diagonals drawn. See A217748. - Martin Renner, Mar 23 2013
a(n) is the number of partitions of 2n into exactly 2 even parts. a(n+1) is the number of partitions of 2n into exactly 2 odd parts. This just rephrases the comment of E. Deutsch above. - Wesley Ivan Hurt, Jun 08 2013
Number of the distinct rectangles and square in a regular n-gon is a(n/2) for even n and n >= 4. For odd n, such number is zero, see illustration in link. - Kival Ngaokrajang, Jun 25 2013
x-coordinate from the image of the point (0,-1) after n reflections across the lines y = n and y = x respectively (alternating so that one reflection is applied on each step): (0,-1) -> (0,1) -> (1,0) -> (1,2) -> (2,1) -> (2,3) -> ... . - Wesley Ivan Hurt, Jul 12 2013
a(n) is the number of partitions of 2n into exactly two distinct odd parts. a(n-1) is the number of partitions of 2n into exactly two distinct even parts, n > 0. - Wesley Ivan Hurt, Jul 21 2013
a(n) is the number of permutations of length n avoiding 213, 231 and 312, or avoiding 213, 312 and 321 in the classical sense which are breadth-first search reading words of increasing unary-binary trees. For more details, see the entry for permutations avoiding 231 at A245898. - Manda Riehl, Aug 05 2014
Also a(n) is the number of different patterns of 2-color, 2-partition of n. - Ctibor O. Zizka, Nov 19 2014
Minimum in- and out-degree for a directed K_n (see link). - Jon Perry, Nov 22 2014
a(n) is also the independence number of the triangular graph T(n). - Luis Manuel Rivera Martínez, Mar 12 2015
For n >= 3, a(n+4) is the least positive integer m such that every m-element subset of {1,2,...,n} contains distinct i, j, k with i + j = k (equivalently, with i - j = k). - Rick L. Shepherd, Jan 24 2016
More generally, the ordinary generating function for the integers repeated k times is x^k/((1 - x)(1 - x^k)). - Ilya Gutkovskiy, Mar 21 2016
a(n) is the number of numbers of the form F(i)*F(j) between F(n+3) and F(n+4), where 2 < i < j and F = A000045 (Fibonacci numbers). - Clark Kimberling, May 02 2016
The arithmetic function v_2(n,2) as defined in A289187. - Robert Price, Aug 22 2017
a(n) is also the total domination number of the (n-3)-gear graph. - Eric W. Weisstein, Apr 07 2018
Consider the numbers 1, 2, ..., n; a(n) is the largest integer t such that these numbers can be arranged in a row so that all consecutive terms differ by at least t. Example: a(6) = a(7) = 3, because of respectively (4, 1, 5, 2, 6, 3) and (1, 5, 2, 6, 3, 7, 4) (see link BMO - Problem 2). - Bernard Schott, Mar 07 2020
a(n-1) is also the number of integer-sided triangles whose sides a < b < c are in arithmetic progression with a middle side b = n (see A307136). Example, for b = 4, there exists a(3) = 1 such triangle corresponding to Pythagorean triple (3, 4, 5). For the triples, miscellaneous properties and references, see A336750. - Bernard Schott, Oct 15 2020
For n >= 1, a(n-1) is the greatest remainder on division of n by any k in 1..n. - David James Sycamore, Sep 05 2021
Number of incongruent right triangles that can be formed from the vertices of a regular n-gon is given by a(n/2) for n even. For n odd such number is zero. For a regular n-gon, the number of incongruent triangles formed from its vertices is given by A069905(n). The number of incongruent acute triangles is given by A005044(n). The number of incongruent obtuse triangles is given by A008642(n-4) for n > 3 otherwise 0, with offset 0. - Frank M Jackson, Nov 26 2022
The inverse binomial transform is 0, 0, 1, -2, 4, -8, 16, -32, ... (see A122803). - R. J. Mathar, Feb 25 2023
REFERENCES
G. L. Alexanderson et al., The William Powell Putnam Mathematical Competition - Problems and Solutions: 1965-1984, M.A.A., 1985; see Problem A-1 of 27th Competition.
L. Comtet, Advanced Combinatorics, Reidel, 1974, p. 120, P(n,2).
Graham, Knuth and Patashnik, Concrete Mathematics, Addison-Wesley, NY, 1989, page 77 (partitions of n into at most 2 parts).
LINKS
Jonathan Bloom and Nathan McNew, Counting pattern-avoiding integer partitions, arXiv:1908.03953 [math.CO], 2019.
British Mathematical Olympiad, 2011/2012 - Round 1 - Problem 2.
Shalosh B. Ekhad and Doron Zeilberger, In How many ways can I carry a total of n coins in my two pockets, and have the same amount in both pockets?, arXiv:1901.08172 [math.CO], 2019.
Andreas M. Hinz and Paul K. Stockmeyer, Precious Metal Sequences and Sierpinski-Type Graphs, J. Integer Seq., Vol 25 (2022), Article 22.4.8.
John A. Pelesko, Generalizing the Conway-Hofstadter $10,000 Sequence, Journal of Integer Sequences, Vol. 7 (2004), Article 04.3.5.
William A. Stein, The modular forms database.
Eric Weisstein's World of Mathematics, Gear Graph.
Eric Weisstein's World of Mathematics, Prime Partition
Eric Weisstein's World of Mathematics, Total Domination Number.
FORMULA
G.f.: x^2/((1+x)*(x-1)^2).
a(n) = floor(n/2).
a(n) = ceiling((n+1)/2). - Eric W. Weisstein, Jan 11 2024
a(n) = 1 + a(n-2).
a(n) = a(n-1) + a(n-2) - a(n-3).
a(2*n) = a(2*n+1) = n.
a(n+1) = n - a(n). - Henry Bottomley, Jul 25 2001
For n > 0, a(n) = Sum_{i=1..n} (1/2)/cos(Pi*(2*i-(1-(-1)^n)/2)/(2*n+1)). - Benoit Cloitre, Oct 11 2002
a(n) = (2*n-1)/4 + (-1)^n/4; a(n+1) = Sum_{k=0..n} k*(-1)^(n+k). - Paul Barry, May 20 2003
E.g.f.: ((2*x-1)*exp(x) + exp(-x))/4. - Paul Barry, Sep 03 2003
G.f.: (1/(1-x)) * Sum_{k >= 0} t^2/(1-t^4) where t = x^2^k. - Ralf Stephan, Feb 24 2004
a(n+1) = A000120(A001045(n)). - Paul Barry, Jan 13 2005
a(n) = (n-(1-(-1)^n)/2)/2 = (1/2)*(n-|sin(n*Pi/2)|). Likewise: a(n) = (n-A000035(n))/2. Also: a(n) = Sum_{k=0..n} A000035(k). - Hieronymus Fischer, Jun 01 2007
The expression floor((x^2-1)/(2*x)) (x >= 1) produces this sequence. - Mohammad K. Azarian, Nov 08 2007; corrected by M. F. Hasler, Nov 17 2008
a(n+1) = A002378(n) - A035608(n). - Reinhard Zumkeller, Jan 27 2010
a(n+1) = A002620(n+1) - A002620(n) = floor((n+1)/2)*ceiling((n+1)/2) - floor(n^2/4). - Jonathan Vos Post, May 20 2010
For n >= 2, a(n) = floor(log_2(2^a(n-1) + 2^a(n-2))). - Vladimir Shevelev, Jun 22 2010
a(n) = A180969(2,n). - Adriano Caroli, Nov 24 2010
A001057(n-1) = (-1)^n*a(n), n > 0. - M. F. Hasler, Jul 19 2012
a(n) = A008615(n) + A002264(n). - Reinhard Zumkeller, Apr 28 2014
Euler transform of length 2 sequence [1, 1]. - Michael Somos, Jul 03 2014
EXAMPLE
G.f. = x^2 + x^3 + 2*x^4 + 2*x^5 + 3*x^6 + 3*x^7 + 4*x^8 + 4*x^9 + 5*x^10 + ...
MAPLE
A004526 := n->floor(n/2); seq(floor(i/2), i=0..50);
MATHEMATICA
Table[(2n - 1)/4 + (-1)^n/4, {n, 0, 70}] (* Stefan Steinerberger, Apr 02 2006 *)
f[n_] := If[OddQ[n], (n - 1)/2, n/2]; Array[f, 74, 0] (* Robert G. Wilson v, Apr 20 2012 *)
With[{c=Range[0, 40]}, Riffle[c, c]] (* Harvey P. Dale, Aug 26 2013 *)
CoefficientList[Series[x^2/(1 - x - x^2 + x^3), {x, 0, 75}], x] (* Robert G. Wilson v, Feb 05 2015 *)
LinearRecurrence[{1, 1, -1}, {0, 0, 1}, 75] (* Robert G. Wilson v, Feb 05 2015 *)
Floor[Range[0, 40]/2] (* Eric W. Weisstein, Apr 07 2018 *)
PROG
(PARI) a(n)=n\2 /* Jaume Oliver Lafont, Mar 25 2009 */
(PARI) x='x+O('x^100); concat([0, 0], Vec(x^2/((1+x)*(x-1)^2))) \\ Altug Alkan, Mar 21 2016
(Haskell)
a004526 = (`div` 2)
a004526_list = concatMap (\x -> [x, x]) [0..]
-- Reinhard Zumkeller, Jul 27 2012
(Maxima) makelist(floor(n/2), n, 0, 50); /* Martin Ettl, Oct 17 2012 */
(Sage) def a(n) : return( dimension_cusp_forms( Gamma0(2), 2*n+4) ); # Michael Somos, Jul 03 2014
(Sage) def a(n) : return( dimension_modular_forms( Gamma1(n+1), 1) ); # Michael Somos, Jul 03 2014
(Magma) [Floor(n/2): n in [0..100]]; // Vincenzo Librandi, Nov 19 2014
(Python)
def a(n): return n//2
print([a(n) for n in range(74)]) # Michael S. Branicky, Apr 30 2022
CROSSREFS
a(n+2) = A008619(n). See A008619 for more references.
A001477(n) = a(n+1)+a(n). A000035(n) = a(n+1)-A002456(n).
a(n) = A008284(n, 2), n >= 1.
Zero followed by the partial sums of A000035.
Column 2 of triangle A094953. Second row of A180969.
Partial sums: A002620. Other related sequences: A010872, A010873, A010874.
Cf. similar sequences of the integers repeated k times: A001477 (k = 1), this sequence (k = 2), A002264 (k = 3), A002265 (k = 4), A002266 (k = 5), A152467 (k = 6), A132270 (k = 7), A132292 (k = 8), A059995 (k = 10).
Cf. A289187, A139756 (binomial transf).
KEYWORD
nonn,easy,core,nice
EXTENSIONS
Partially edited by Joerg Arndt, Mar 11 2010, and M. F. Hasler, Jul 19 2012
STATUS
approved
a(n) is the number of partitions of n into at most 3 parts; also partitions of n+3 in which the greatest part is 3; also number of unlabeled multigraphs with 3 nodes and n edges.
(Formerly M0518 N0186)
+10
196
1, 1, 2, 3, 4, 5, 7, 8, 10, 12, 14, 16, 19, 21, 24, 27, 30, 33, 37, 40, 44, 48, 52, 56, 61, 65, 70, 75, 80, 85, 91, 96, 102, 108, 114, 120, 127, 133, 140, 147, 154, 161, 169, 176, 184, 192, 200, 208, 217, 225, 234, 243, 252, 261, 271, 280, 290, 300, 310, 320, 331, 341
OFFSET
0,3
COMMENTS
Also number of tripods (trees with exactly 3 leaves) on n vertices. - Eric W. Weisstein, Mar 05 2011
Also number of partitions of n+3 into exactly 3 parts; number of partitions of n in which the greatest part is less than or equal to 3; and the number of nonnegative solutions to b + 2c + 3d = n.
Also a(n) gives number of partitions of n+6 into 3 distinct parts and number of partitions of 2n+9 into 3 distinct and odd parts, e.g., 15 = 11 + 3 + 1 = 9 + 5 + 1 = 7 + 5 + 3. - Jon Perry, Jan 07 2004
Also bracelets with n+3 beads 3 of which are red (so there are 2 possibilities with 5 beads).
More generally, the number of partitions of n into at most k parts is also the number of partitions of n+k into k positive parts, the number of partitions of n+k in which the greatest part is k, the number of partitions of n in which the greatest part is less than or equal to k, the number of partitions of n+k(k+1)/2 into exactly k distinct positive parts, the number of nonnegative solutions to b + 2c + 3d + ... + kz = n and the number of nonnegative solutions to 2c + 3d + ... + kz <= n. - Henry Bottomley, Apr 17 2001
Also coefficient of q^n in the expansion of (m choose 3)_q as m goes to infinity. - Y. Kelly Itakura (yitkr(AT)mta.ca), Aug 21 2002
From Winston C. Yang (winston(AT)cs.wisc.edu), Apr 30 2002: (Start)
Write 1,2,3,4,... in a hexagonal spiral around 0, then a(n) for n > 0 is formed by the folding points (including the initial 1). The spiral begins:
.
85--84--83--82--81--80
/ \
86 56--55--54--53--52 79
/ / \ \
87 57 33--32--31--30 51 78
/ / / \ \ \
88 58 34 16--15--14 29 50 77
/ / / / \ \ \ \
89 59 35 17 5---4 13 28 49 76
/ / / / / \ \ \ \ \
90 60 36 18 6 0 3 12 27 48 75
/ / / / / / / / / / /
91 61 37 19 7 1---2 11 26 47 74
\ \ \ \ / / / /
62 38 20 8---9--10 25 46 73
\ \ \ / / /
63 39 21--22--23--24 45 72
\ \ / /
64 40--41--42--43--44 71
\ /
65--66--67--68--69--70
.
a(p) is maximal number of hexagons in a polyhex with perimeter at most 2p + 6. (End)
a(n-3) is the number of partitions of n into 3 distinct parts, where 0 is allowed as a part. E.g., at n=9, we can write 8+1+0, 7+2+0, 6+3+0, 4+5+0, 1+2+6, 1+3+5 and 2+3+4, which is a(6)=7. - Jon Perry, Jul 08 2003
a(n) gives number of partitions of n+6 into parts <=3 where each part is used at least once (subtract 6=1+2+3 from n). - Jon Perry, Jul 03 2004
This is also the number of partitions of n+3 into exactly 3 parts (there is a 1-to-1 correspondence between the number of partitions of n+3 in which the greatest part is 3 and the number of partitions of n+3 into exactly three parts). - Graeme McRae, Feb 07 2005
Apply the Riordan array (1/(1-x^3),x) to floor((n+2)/2). - Paul Barry, Apr 16 2005
Also, number of triangles that can be created with odd perimeter 3,5,7,9,11,... with all sides whole numbers. Note that triangles with even perimeter can be generated from the odd ones by increasing each side by 1. E.g., a(1) = 1 because perimeter 3 can make {1,1,1} 1 triangle. a(4) = 3 because perimeter 9 can make {1,4,4} {2,3,4} {3,3,3} 3 possible triangles. - Bruce Love (bruce_love(AT)ofs.edu.sg), Nov 20 2006
Also number of nonnegative solutions of the Diophantine equation x+2*y+3*z=n, cf. Pólya/Szegő reference.
From Vladimir Shevelev, Apr 23 2011: (Start)
Also a(n-3), n >= 3, is the number of non-equivalent necklaces of 3 beads each of them painted by one of n colors.
The sequence {a(n-3), n >= 3} solves the so-called Reis problem about convex k-gons in case k=3 (see our comment to A032279).
a(n-3) (n >= 3) is an essentially unimprovable upper estimate for the number of distinct values of the permanent in (0,1)-circulants of order n with three 1's in every row. (End)
A001399(n) is the number of 3-tuples (w,x,y) having all terms in {0,...,n} and w = 2*x+3*y. - Clark Kimberling, Jun 04 2012
Also, for n >= 3, a(n-3) is the number of the distinct triangles in an n-gon, see the Ngaokrajang links. - Kival Ngaokrajang, Mar 16 2013
Also, a(n) is the total number of 5-curve coin patterns (5C4S type: 5 curves covering full 4 coins and symmetry) packing into fountain of coins base (n+3). See illustration in links. - Kival Ngaokrajang, Oct 16 2013
Also a(n) = half the number of minimal zero sequences for Z_n of length 3 [Ponomarenko]. - N. J. A. Sloane, Feb 25 2014
Also, a(n) equals the number of linearly-independent terms at 2n-th order in the power series expansion of an Octahedral Rotational Energy Surface (cf. Harter & Patterson). - Bradley Klee, Jul 31 2015
Also Molien series for invariants of finite Coxeter groups D_3 and A_3. - N. J. A. Sloane, Jan 10 2016
Number of different distributions of n+6 identical balls in 3 boxes as x,y,z where 0 < x < y < z. - Ece Uslu and Esin Becenen, Jan 11 2016
a(n) is also the number of partitions of 2*n with <= n parts and no part >= 4. The bijection to partitions of n with no part >= 4 is: 1 <-> 2, 2 <-> 1 + 3, 3 <-> 3 + 3 (observing the order of these rules). The <- direction uses the following fact for partitions of 2*n with <= n parts and no part >=4: for each part 1 there is a part 3, and an even number (including 0) of remaining parts 3. - Wolfdieter Lang, May 21 2019
List of the terms in A000567(n>=1), A049450(n>=1), A033428(n>=1), A049451(n>=1), A045944(n>=1), and A003215(n) in nondecreasing order. List of the numbers A056105(n)-1, A056106(n)-1, A056107(n)-1, A056108(n)-1, A056109(n)-1, and A003215(m) with n >= 1 and m >= 0 in nondecreasing order. Numbers of the forms 3n*(n-1)+1, n*(3n-2), n*(3n-1), 3n^2, n*(3n+1), n*(3n+2) with n >= 1 listed in nondecreasing order. Integers m such that lattice points from 1 through m on a hexagonal spiral starting at 1 forms a convex polygon. - Ya-Ping Lu, Jan 24 2024
REFERENCES
R. Ayoub, An Introduction to the Analytic Theory of Numbers, Amer. Math. Soc., 1963; Chapter III, Problem 33.
L. Comtet, Advanced Combinatorics, Reidel, 1974, p. 110, D(n); page 263, #18, P_n^{3}.
J. L. Gross and J. Yellen, eds., Handbook of Graph Theory, CRC Press, 2004; p. 517.
H. Gupta et al., Tables of Partitions. Royal Society Mathematical Tables, Vol. 4, Cambridge Univ. Press, 1958, p. 2.
F. Harary and E. M. Palmer, Graphical Enumeration, Academic Press, NY, 1973, p. 88, (4.1.18).
G. H. Hardy and E. M. Wright, An Introduction to the Theory of Numbers. 3rd ed., Oxford Univ. Press, 1954, p. 275.
R. Honsberger, Mathematical Gems III, Math. Assoc. Amer., 1985, p. 39.
J. H. van Lint, Combinatorial Seminar Eindhoven, Lecture Notes Math., 382 (1974), see pp. 33-34.
G. Pólya and G. Szegő, Problems and Theorems in Analysis I (Springer 1924, reprinted 1972), Part One, Chap. 1, Sect. 1, Problem 25.
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
Marius A. Burtea, Table of n, a(n) for n = 0..17501 (terms 0..1000 from T. D. Noe, terms 14001 onwards corrected by Sean A. Irvine, April 25 2019)
Hamid Afshar, Branislav Cvetkovic, Sabine Ertl, Daniel Grumiller, and Niklas Johansson, Conformal Chern-Simons holography-lock, stock and barrel, arXiv preprint arXiv:1110.5644 [hep-th], 2011.
C. Ahmed, P. Martin, and V. Mazorchuk, On the number of principal ideals in d-tonal partition monoids, arXiv preprint arXiv:1503.06718 [math.CO], 2015.
Nesrine Benyahia-Tani, Zahra Yahi, and Sadek Bouroubi, Ordered and non-ordered non-congruent convex quadrilaterals inscribed in a regular n-gon, Rostocker Math. Kolloq. 68 (2013), 71-79.
N. Benyahia Tani, Z. Yahi, and S. Bouroubi, Ordered and non-ordered non-isometric convex quadrilaterals inscribed in a regular n-gon, Bulletin du Laboratoire Liforce 01 (2014), 1-9.
Jonathan Bloom and Nathan McNew, Counting pattern-avoiding integer partitions, arXiv:1908.03953 [math.CO], 2019.
P. J. Cameron, Sequences realized by oligomorphic permutation groups, J. Integ. Seqs. Vol. 3 (2000), #00.1.5.
S. J. Cyvin, B. N. Cyvin, J. Brunvoll, I. Gutman, Chen Rong-si, S. El-Basil, and Zhang Fuji, Polygonal Systems Including the Corannulene and Coronene Homologs: Novel Applications of Pólya's Theorem, Z. Naturforsch., 52a (1997), 867-873.
Lucia De Luca and Gero Friesecke, Classification of particle numbers with unique Heitmann-Radin minimizer, arXiv:1701.07231 [math-ph], 2017.
Nick Fischer and Christian Ikenmeyer, The Computational Complexity of Plethysm Coefficients, arXiv:2002.00788 [cs.CC], 2020.
H. Gupta, Enumeration of incongruent cyclic k-gons, Indian J. Pure and Appl. Math., 10 (1979), no.8, 964-999.
W. G. Harter and C. W. Patterson, Asymptotic eigensolutions of fourth and sixth rank octahedral tensor operators, Journal of Mathematical Physics, 20.7 (1979), 1453-1459. alternate copy
M. D. Hirschhorn and J. A. Sellers, Enumeration of unigraphical partitions, JIS 11 (2008) 08.4.6.
R. Honsberger, Mathematical Gems III, Math. Assoc. Amer., 1985, p. 39. [Annotated scanned copy]
J. H. Jordan, R. Walch, and R. J. Wisner, Triangles with integer sides, Amer. Math. Monthly 86 (1979), 686-689.
Alexander V. Karpov, An Informational Basis for Voting Rules, NRU Higher School of Economics. Series WP BRP "Economics/EC". 2018. No. 188.
Gerzson Keri and Patric R. J. Östergård, The Number of Inequivalent (2R+3,7)R Optimal Covering Codes, Journal of Integer Sequences 9 (2006), Article 06.4.7.
Clark Kimberling, A Combinatorial Classification of Triangle Centers on the Line at Infinity, J. Int. Seq., Vol. 22 (2019), Article 19.5.4.
Axel Kleinschmidt and Valentin Verschinin, Tetrahedral modular graph functions, J. High Energy Phys. 2017, No. 9, Paper No. 155, 38 p. (2017), eq (3.40).
Mathematics Stack Exchange, What does "pcr" stand for. [This is Comtet's notation for "prime circulator". See pp. 109-110.]
M. B. Nathanson, Partitions with parts in a finite set, arXiv:math/0002098 [math.NT], 2000.
Andrew N. Norris, Higher derivatives and the inverse derivative of a tensor-valued function of a tensor, arXiv:0707.0115 [math.SP], 2007; Equation 3.28, p. 10.
Simon Plouffe, Approximations de séries génératrices et quelques conjectures, Dissertation, Université du Québec à Montréal, 1992; arXiv:0911.4975 [math.NT], 2009.
Simon Plouffe, 1031 Generating Functions, Appendix to Thesis, Montreal, 1992.
Vadim Ponomarenko, Minimal zero sequences of finite cyclic groups, INTEGERS 4 (2004), #A24.
Vladimir Shevelev, Necklaces and convex k-gons, Indian J. Pure and Appl. Math. 35(5) (2004), 629-638.
Vladimir Shevelev, Spectrum of permanent's values and its extremal magnitudes in Lambda_n^3 and Lambda_n(alpha,beta,gamma), arXiv:1104.4051 [math.CO], 2011. (Cf. Section 5).
Devansh Singh and S. N. Mishra, Representing K-parts Integer Partitions, Global Journal of Pure and Applied Mathematics (GJPAM), Volume 15 Number 6 (2019), pp. 889-907.
Karl Hermann Struve, Fresnel's Interferenzerscheinungen: Theoretisch und Experimentell Bearbeitet, Dorpat, 1881 (Thesis). [Gives the Round(n^2/12) formula.]
James Tanton, Young students approach integer triangles, FOCUS 22(5) (2002), 4 - 6.
James Tanton, Integer Triangles, Chapter 11 in "Mathematics Galore!" (MAA, 2012).
James Tilley, Stan Wagon, and Eric Weisstein, A Catalog of Facially Complete Graphs, arXiv:2409.11249 [math.CO], 2024. See p. 11.
Richard Vale and Shayne Waldron, The construction of G-invariant finite tight frames, J. Four. Anal. Applic. 22 (2016), 1097-1120.
Eric Weisstein's World of Mathematics, Tripod.
Winston C. Yang, Maximal and minimal polyhexes, 2002.
FORMULA
G.f.: 1/((1 - x) * (1 - x^2) * (1 - x^3)) = -1/((x+1)*(x^2+x+1)*(x-1)^3); Simon Plouffe in his 1992 dissertation
a(n) = round((n + 3)^2/12). Note that this cannot be of the form (2*i + 1)/2, so ties never arise.
a(n) = A008284(n+3, 3), n >= 0.
a(n) = 1 + a(n-2) + a(n-3) - a(n-5) for all n in Z. - Michael Somos, Sep 04 2006
a(n) = a(-6 - n) for all n in Z. - Michael Somos, Sep 04 2006
a(6*n) = A003215(n), a(6*n + 1) = A000567(n + 1), a(6*n + 2) = A049450(n + 1), a(6*n + 3) = A033428(n + 1), a(6*n + 4) = A049451(n + 1), a(6*n + 5) = A045944(n + 1).
a(n) = a(n-1) + A008615(n+2) = a(n-2) + A008620(n) = a(n-3) + A008619(n) = A001840(n+1) - a(n-1) = A002620(n+2) - A001840(n) = A000601(n) - A000601(n-1). - Henry Bottomley, Apr 17 2001
P(n, 3) = (1/72) * (6*n^2 - 7 - 9*pcr{1, -1}(2, n) + 8*pcr{2, -1, -1}(3, n)) (see Comtet). [Here "pcr" stands for "prime circulator" and it is defined on p. 109 of Comtet, while the formula appears on p. 110. - Petros Hadjicostas, Oct 03 2019]
Let m > 0 and -3 <= p <= 2 be defined by n = 6*m+p-3; then for n > -3, a(n) = 3*m^2 + p*m, and for n = -3, a(n) = 3*m^2 + p*m + 1. - Floor van Lamoen, Jul 23 2001
72*a(n) = 17 + 6*(n+1)*(n+5) + 9*(-1)^n - 8*A061347(n). - Benoit Cloitre, Feb 09 2003
From Jon Perry, Jun 17 2003: (Start)
a(n) = 6*t(floor(n/6)) + (n%6) * (floor(n/6) + 1) + (n mod 6 == 0?1:0), where t(n) = n*(n+1)/2.
a(n) = ceiling(1/12*n^2 + 1/2*n) + (n mod 6 == 0?1:0).
[Here "n%6" means "n mod 6" while "(n mod 6 == 0?1:0)" means "if n mod 6 == 0 then 1, else 0" (as in C).]
(End)
a(n) = Sum_{i=0..floor(n/3)} 1 + floor((n - 3*i)/2). - Jon Perry, Jun 27 2003
a(n) = Sum_{k=0..n} floor((k + 2)/2) * (cos(2*Pi*(n - k)/3 + Pi/3)/3 + sqrt(3) * sin(2*Pi*(n-k)/3 + Pi/3)/3 + 1/3). - Paul Barry, Apr 16 2005
(m choose 3)_q = (q^m-1) * (q^(m-1) - 1) * (q^(m-2) - 1)/((q^3 - 1) * (q^2 - 1) * (q - 1)).
a(n) = Sum_{k=0..floor(n/2)} floor((3 + n - 2*k)/3). - Paul Barry, Nov 11 2003
A117220(n) = a(A003586(n)). - Reinhard Zumkeller, Mar 04 2006
a(n) = 3 * Sum_{i=2..n+1} floor(i/2) - floor(i/3). - Thomas Wieder, Feb 11 2007
Identical to the number of points inside or on the boundary of the integer grid of {I, J}, bounded by the three straight lines I = 0, I - J = 0 and I + 2J = n. - Jonathan Vos Post, Jul 03 2007
a(n) = A026820(n,3) for n > 2. - Reinhard Zumkeller, Jan 21 2010
Euler transform of length 3 sequence [ 1, 1, 1]. - Michael Somos, Feb 25 2012
a(n) = A005044(2*n + 3) = A005044(2*n + 6). - Michael Somos, Feb 25 2012
a(n) = A000212(n+3) - A002620(n+3). - Richard R. Forberg, Dec 08 2013
a(n) = a(n-1) + a(n-2) - a(n-4) - a(n-5) + a(n-6). - David Neil McGrath, Feb 14 2015
a(n) = floor((n^2+3)/12) + floor((n+2)/2). - Giacomo Guglieri, Apr 02 2019
From Devansh Singh, May 28 2020: (Start)
Let p(n, 3) be the number of 3-part integer partitions in which every part is > 0.
Then for n >= 3, p(n, 3) is equal to:
(n^2 - 1)/12 when n is odd and 3 does not divide n.
(n^2 + 3)/12 when n is odd and 3 divides n.
(n^2 - 4)/12 when n is even and 3 does not divide n.
(n^2)/12 when n is even and 3 divides n.
For n >= 3, p(n, 3) = a(n-3). (End)
a(n) = floor(((n+3)^2 + 4)/12). - Vladimír Modrák, Zuzana Soltysova, Dec 08 2020
Sum_{n>=0} 1/a(n) = 15/4 - Pi/(2*sqrt(3)) + Pi^2/18 + tanh(Pi/(2*sqrt(3)))*Pi/sqrt(3). - Amiram Eldar, Sep 29 2022
E.g.f.: exp(-x)*(9 + exp(2*x)*(47 + 42*x + 6*x^2) + 16*exp(x/2)*cos(sqrt(3)*x/2))/72. - Stefano Spezia, Mar 05 2023
a(6n) = 1+6*A000217(n); Sum_{i=1..n} a(6*i) = A000578(n+1). - David García Herrero, May 05 2024
EXAMPLE
G.f. = 1 + x + 2*x^2 + 3*x^3 + 4*x^4 + 5*x^5 + 7*x^6 + 8*x^7 + 10*x^8 + 12*x^9 + ...
Recall that in a necklace the adjacent beads have distinct colors. Suppose we have n colors with labels 1,...,n. Two colorings of the beads are equivalent if the cyclic sequences of the distances modulo n between labels of adjacent colors have the same period. If n=4, all colorings are equivalent. E.g., for the colorings {1,2,3} and {1,2,4} we have the same period {1,1,2} of distances modulo 4. So, a(n-3)=a(1)=1. If n=5, then we have two such periods {1,1,3} and {1,2,2} modulo 5. Thus a(2)=2. - Vladimir Shevelev, Apr 23 2011
a(0) = 1, i.e., {1,2,3} Number of different distributions of 6 identical balls to 3 boxes as x,y and z where 0 < x < y < z. - Ece Uslu, Esin Becenen, Jan 11 2016
a(3) = 3, i.e., {1,2,6}, {1,3,5}, {2,3,4} Number of different distributions of 9 identical balls in 3 boxes as x,y and z where 0 < x < y < z. - Ece Uslu, Esin Becenen, Jan 11 2016
From Gus Wiseman, Apr 15 2019: (Start)
The a(0) = 1 through a(8) = 10 integer partitions of n with at most three parts are the following. The Heinz numbers of these partitions are given by A037144.
() (1) (2) (3) (4) (5) (6) (7) (8)
(11) (21) (22) (32) (33) (43) (44)
(111) (31) (41) (42) (52) (53)
(211) (221) (51) (61) (62)
(311) (222) (322) (71)
(321) (331) (332)
(411) (421) (422)
(511) (431)
(521)
(611)
The a(0) = 1 through a(7) = 8 integer partitions of n + 3 whose greatest part is 3 are the following. The Heinz numbers of these partitions are given by A080193.
(3) (31) (32) (33) (322) (332) (333) (3322)
(311) (321) (331) (3221) (3222) (3331)
(3111) (3211) (3311) (3321) (32221)
(31111) (32111) (32211) (33211)
(311111) (33111) (322111)
(321111) (331111)
(3111111) (3211111)
(31111111)
Non-isomorphic representatives of the a(0) = 1 through a(5) = 5 unlabeled multigraphs with 3 vertices and n edges are the following.
{} {12} {12,12} {12,12,12} {12,12,12,12} {12,12,12,12,12}
{13,23} {12,13,23} {12,13,23,23} {12,13,13,23,23}
{13,23,23} {13,13,23,23} {12,13,23,23,23}
{13,23,23,23} {13,13,23,23,23}
{13,23,23,23,23}
The a(0) = 1 through a(8) = 10 strict integer partitions of n - 6 with three parts are the following (A = 10, B = 11). The Heinz numbers of these partitions are given by A007304.
(321) (421) (431) (432) (532) (542) (543) (643) (653)
(521) (531) (541) (632) (642) (652) (743)
(621) (631) (641) (651) (742) (752)
(721) (731) (732) (751) (761)
(821) (741) (832) (842)
(831) (841) (851)
(921) (931) (932)
(A21) (941)
(A31)
(B21)
The a(0) = 1 through a(8) = 10 integer partitions of n + 3 with three parts are the following. The Heinz numbers of these partitions are given by A014612.
(111) (211) (221) (222) (322) (332) (333) (433) (443)
(311) (321) (331) (422) (432) (442) (533)
(411) (421) (431) (441) (532) (542)
(511) (521) (522) (541) (551)
(611) (531) (622) (632)
(621) (631) (641)
(711) (721) (722)
(811) (731)
(821)
(911)
The a(0) = 1 through a(8) = 10 integer partitions of n whose greatest part is <= 3 are the following. The Heinz numbers of these partitions are given by A051037.
() (1) (2) (3) (22) (32) (33) (322) (332)
(11) (21) (31) (221) (222) (331) (2222)
(111) (211) (311) (321) (2221) (3221)
(1111) (2111) (2211) (3211) (3311)
(11111) (3111) (22111) (22211)
(21111) (31111) (32111)
(111111) (211111) (221111)
(1111111) (311111)
(2111111)
(11111111)
The a(0) = 1 through a(6) = 7 strict integer partitions of 2n+9 with 3 parts, all of which are odd, are the following. The Heinz numbers of these partitions are given by A307534.
(5,3,1) (7,3,1) (7,5,1) (7,5,3) (9,5,3) (9,7,3) (9,7,5)
(9,3,1) (9,5,1) (9,7,1) (11,5,3) (11,7,3)
(11,3,1) (11,5,1) (11,7,1) (11,9,1)
(13,3,1) (13,5,1) (13,5,3)
(15,3,1) (13,7,1)
(15,5,1)
(17,3,1)
The a(0) = 1 through a(8) = 10 strict integer partitions of n + 3 with 3 parts where 0 is allowed as a part (A = 10):
(210) (310) (320) (420) (430) (530) (540) (640) (650)
(410) (510) (520) (620) (630) (730) (740)
(321) (610) (710) (720) (820) (830)
(421) (431) (810) (910) (920)
(521) (432) (532) (A10)
(531) (541) (542)
(621) (631) (632)
(721) (641)
(731)
(821)
The a(0) = 1 through a(7) = 7 integer partitions of n + 6 whose distinct parts are 1, 2, and 3 are the following. The Heinz numbers of these partitions are given by A143207.
(321) (3211) (3221) (3321) (32221) (33221) (33321)
(32111) (32211) (33211) (322211) (322221)
(321111) (322111) (332111) (332211)
(3211111) (3221111) (3222111)
(32111111) (3321111)
(32211111)
(321111111)
(End)
Partitions of 2*n with <= n parts and no part >= 4: a(3) = 3 from (2^3), (1,2,3), (3^2) mapping to (1^3), (1,2), (3), the partitions of 3 with no part >= 4, respectively. - Wolfdieter Lang, May 21 2019
MAPLE
A001399 := proc(n)
round( (n+3)^2/12) ;
end proc:
seq(A001399(n), n=0..40) ;
with(combstruct):ZL4:=[S, {S=Set(Cycle(Z, card<4))}, unlabeled]:seq(count(ZL4, size=n), n=0..61); # Zerinvary Lajos, Sep 24 2007
B:=[S, {S = Set(Sequence(Z, 1 <= card), card <=3)}, unlabelled]: seq(combstruct[count](B, size=n), n=0..61); # Zerinvary Lajos, Mar 21 2009
MATHEMATICA
CoefficientList[ Series[ 1/((1 - x)*(1 - x^2)*(1 - x^3)), {x, 0, 65} ], x ]
Table[ Length[ IntegerPartitions[n, 3]], {n, 0, 61} ] (* corrected by Jean-François Alcover, Aug 08 2012 *)
k = 3; Table[(Apply[Plus, Map[EulerPhi[ # ]Binomial[n/#, k/# ] &, Divisors[GCD[n, k]]]]/n + Binomial[If[OddQ[n], n - 1, n - If[OddQ[k], 2, 0]]/2, If[OddQ[k], k - 1, k]/2])/2, {n, k, 50}] (* Robert A. Russell, Sep 27 2004 *)
LinearRecurrence[{1, 1, 0, -1, -1, 1}, {1, 1, 2, 3, 4, 5}, 70] (* Harvey P. Dale, Jun 21 2012 *)
a[ n_] := With[{m = Abs[n + 3] - 3}, Length[ IntegerPartitions[ m, 3]]]; (* Michael Somos, Dec 25 2014 *)
k=3 (* Number of red beads in bracelet problem *); CoefficientList[Series[(1/k Plus@@(EulerPhi[#] (1-x^#)^(-(k/#))&/@Divisors[k])+(1+x)/(1-x^2)^Floor[(k+2)/2])/2, {x, 0, 50}], x] (* Herbert Kociemba, Nov 04 2016 *)
Table[Length[Select[IntegerPartitions[n, {3}], UnsameQ@@#&]], {n, 0, 30}] (* Gus Wiseman, Apr 15 2019 *)
PROG
(PARI) {a(n) = round((n + 3)^2 / 12)}; /* Michael Somos, Sep 04 2006 */
(Haskell)
a001399 = p [1, 2, 3] where
p _ 0 = 1
p [] _ = 0
p ks'@(k:ks) m = if m < k then 0 else p ks' (m - k) + p ks m
-- Reinhard Zumkeller, Feb 28 2013
(Magma) I:=[1, 1, 2, 3, 4, 5]; [n le 6 select I[n] else Self(n-1)+Self(n-2)-Self(n-4)-Self(n-5)+Self(n-6): n in [1..80]]; // Vincenzo Librandi, Feb 14 2015
(Magma) [#RestrictedPartitions(n, {1, 2, 3}): n in [0..62]]; // Marius A. Burtea, Jan 06 2019
(Magma) [Round((n+3)^2/12): n in [0..70]]; // Marius A. Burtea, Jan 06 2019
(Python) [print(round((n+3)**2/12), end = ', ') for n in range(0, 62)] # Ya-Ping Lu, Jan 24 2024
CROSSREFS
Molien series for finite Coxeter groups D_3 through D_12 are A001399, A051263, A266744-A266751.
KEYWORD
nonn,easy,nice
EXTENSIONS
Name edited by Gus Wiseman, Apr 15 2019
STATUS
approved
a(n) = 6*n + 1.
+10
133
1, 7, 13, 19, 25, 31, 37, 43, 49, 55, 61, 67, 73, 79, 85, 91, 97, 103, 109, 115, 121, 127, 133, 139, 145, 151, 157, 163, 169, 175, 181, 187, 193, 199, 205, 211, 217, 223, 229, 235, 241, 247, 253, 259, 265, 271, 277, 283, 289, 295, 301, 307, 313, 319, 325, 331
OFFSET
0,2
COMMENTS
Apart from initial term(s), dimension of the space of weight 2n cusp forms for Gamma_0( 22 ).
Also solutions to 2^x + 3^x == 5 (mod 7). - Cino Hilliard, May 10 2003
Except for 1, exponents n > 1 such that x^n - x^2 - 1 is reducible. - N. J. A. Sloane, Jul 19 2005
Let M(n) be the n X n matrix m(i,j) = min(i,j); then the trace of M(n)^(-2) is a(n-1) = 6*n - 5. - Benoit Cloitre, Feb 09 2006
If Y is a 3-subset of an (2n+1)-set X then, for n >= 3, a(n-1) is the number of 3-subsets of X having at least two elements in common with Y. - Milan Janjic, Dec 16 2007
All composite terms belong to A269345 as shown in there. - Waldemar Puszkarz, Apr 13 2016
First differences of the number of active (ON, black) cells in n-th stage of growth of two-dimensional cellular automaton defined by "Rule 773", based on the 5-celled von Neumann neighborhood. - Robert Price, May 23 2016
For b(n) = A103221(n) one has b(a(n)-1) = b(a(n)+1) = b(a(n)+2) = b(a(n)+3) = b(a(n)+4) = n+1 but b(a(n)) = n. So-called "dips" in A103221. See the Avner and Gross remark on p. 178. - Wolfdieter Lang, Sep 16 2016
A (n+1,n) pebbling move involves removing n + 1 pebbles from a vertex in a simple graph and placing n pebbles on an adjacent vertex. A two-player impartial (n+1,n) pebbling game involves two players alternating (n+1,n) pebbling moves. The first player unable to make a move loses. The sequence a(n) is also the minimum number of pebbles such that any assignment of those pebbles on a complete graph with 3 vertices is a next-player winning game in the two player impartial (k+1,k) pebbling game. These games are represented by A347637(3,n). - Joe Miller, Oct 18 2021
Interleaving of A017533 and A017605. - Leo Tavares, Nov 16 2021
REFERENCES
Avner Ash and Robert Gross, Summing it up, Princeton University Press, 2016, p. 178.
LINKS
Kayla Barker, Mia DeStefano, Eugene Fiorini, Michael Gohn, Joe Miller, Jacob Roeder, and Tony W. H. Wong, Generalized Impartial Two-player Pebbling Games on K_3 and C_4, J. Int. Seq. (2024) Vol. 27, Issue 5, Art. No. 24.5.8. See p. 3.
Tanya Khovanova, Recursive Sequences.
William A. Stein, The modular forms database.
FORMULA
a(n) = 6*n + 1, n >= 0 (see the name).
G.f.: (1+5*x)/(1-x)^2.
A008615(a(n)) = n. - Reinhard Zumkeller, Feb 27 2008
A157176(a(n)) = A013730(n). - Reinhard Zumkeller, Feb 24 2009
a(n) = 4*(3*n-1) - a(n-1) (with a(0)=1). - Vincenzo Librandi, Nov 20 2010
E.g.f.: (1 + 6*x)*exp(x). - G. C. Greubel, Sep 18 2019
a(n) = A003215(n) - 6*A000217(n-1). See Hexagonal Lines illustration. - Leo Tavares, Sep 10 2021
From Leo Tavares, Oct 27 2021: (Start)
a(n) = 6*A001477(n-1) + 7
a(n) = A016813(n) + 2*A001477(n)
a(n) = A017605(n-1) + A008588(n-1)
a(n) = A016933(n) - 1
a(n) = A008588(n) + 1. (End)
Sum_{n>=0} (-1)^n/a(n) = Pi/6 + sqrt(3)*arccoth(sqrt(3))/3. - Amiram Eldar, Dec 10 2021
EXAMPLE
From Ilya Gutkovskiy, Apr 15 2016: (Start)
Illustration of initial terms:
o
o o o
o o o o
o o o o o o
o o o o o o o
o o o o o o o o o
o o o o o o o o o o
n=0 n=1 n=2 n=3
(End)
MAPLE
a[1]:=1:for n from 2 to 100 do a[n]:=a[n-1]+6 od: seq(a[n], n=1..56); # Zerinvary Lajos, Mar 16 2008
MATHEMATICA
Range[1, 500, 6] (* Vladimir Joseph Stephan Orlovsky, May 26 2011 *)
PROG
(Haskell)
a016921 = (+ 1) . (* 6)
a016921_list = [1, 7 ..] -- Reinhard Zumkeller, Jan 15 2013
(PARI) a(n)=6*n+1 \\ Charles R Greathouse IV, Mar 22 2016
(Python) for n in range(0, 10**5):print(6*n+1) # Soumil Mandal, Apr 14 2016
(Magma) [6*n+1: n in [0..60]]; // G. C. Greubel, Sep 18 2019
(GAP) List([0..60], n-> 6*n+1); # G. C. Greubel, Sep 18 2019
CROSSREFS
Cf. A093563 ((6, 1) Pascal, column m=1).
a(n) = A007310(2*(n+1)); complement of A016969 with respect to A007310.
Cf. A287326 (second column).
KEYWORD
nonn,easy
STATUS
approved
Nonnegative multiples of 6.
+10
130
0, 6, 12, 18, 24, 30, 36, 42, 48, 54, 60, 66, 72, 78, 84, 90, 96, 102, 108, 114, 120, 126, 132, 138, 144, 150, 156, 162, 168, 174, 180, 186, 192, 198, 204, 210, 216, 222, 228, 234, 240, 246, 252, 258, 264, 270, 276, 282, 288, 294, 300, 306, 312, 318, 324, 330, 336, 342, 348
OFFSET
0,2
COMMENTS
For n > 3, the number of squares on the infinite 3-column half-strip chessboard at <= n knight moves from any fixed point on the short edge.
Second differences of A000578. - Cecilia Rossiter (cecilia(AT)noticingnumbers.net), Dec 15 2004
A008615(a(n)) = n. - Reinhard Zumkeller, Feb 27 2008
A157176(a(n)) = A001018(n). - Reinhard Zumkeller, Feb 24 2009
These numbers can be written as the sum of four cubes (i.e., 6*n = (n+1)^3 + (n-1)^3 + (-n)^3 + (-n)^3). - Arkadiusz Wesolowski, Aug 09 2013
A122841(a(n)) > 0 for n > 0. - Reinhard Zumkeller, Nov 10 2013
Surface area of a cube with side sqrt(n). - Wesley Ivan Hurt, Aug 24 2014
a(n) is representable as a sum of three but not two consecutive nonnegative integers, e.g., 6 = 1 + 2 + 3, 12 = 3 + 4 + 5, 18 = 5 + 6 + 7, etc. (see A138591). - Martin Renner, Mar 14 2016 (Corrected by David A. Corneth, Aug 12 2016)
Numbers with three consecutive divisors: for some k, each of k, k+1, and k+2 divide n. - Charles R Greathouse IV, May 16 2016
Numbers k for which {phi(k),phi(2k),phi(3k)} is an arithmetic progression. - Ivan Neretin, Aug 12 2016
FORMULA
From Vincenzo Librandi, Dec 24 2010: (Start)
a(n) = 6*n = 2*a(n-1) - a(n-2).
G.f.: 6*x/(1-x)^2. (End)
a(n) = Sum_{k>=0} A030308(n,k)*6*2^k. - Philippe Deléham, Oct 24 2011
a(n) = Sum_{k=2n-1..2n+1} k. - Wesley Ivan Hurt, Nov 22 2015
From Ilya Gutkovskiy, Aug 12 2016: (Start)
E.g.f.: 6*x*exp(x).
Convolution of A010722 and A057427.
Sum_{n>=1} (-1)^(n+1)/a(n) = log(2)/6 = A002162*A020793. (End)
a(n) = 6 * A001477(n). - David A. Corneth, Aug 12 2016
MAPLE
[ seq(6*n, n=0..45) ];
MATHEMATICA
Range[0, 500, 6] (* Vladimir Joseph Stephan Orlovsky, May 26 2011 *)
PROG
(Magma) [6*n: n in [0..60] ]; // Vincenzo Librandi, Jul 16 2011
(PARI) a(n)=6*n \\ Charles R Greathouse IV, Feb 08 2012
(Maxima) makelist(6*n, n, 0, 30); /* Martin Ettl, Nov 12 2012 */
(Haskell)
a008588 = (* 6)
a008588_list = [0, 6 ..] -- Reinhard Zumkeller, Nov 10 2013
CROSSREFS
Essentially the same as A008458.
Cf. A044102 (subsequence).
KEYWORD
nonn,easy
STATUS
approved
Alcuin's sequence: expansion of x^3/((1-x^2)*(1-x^3)*(1-x^4)).
(Formerly M0146)
+10
126
0, 0, 0, 1, 0, 1, 1, 2, 1, 3, 2, 4, 3, 5, 4, 7, 5, 8, 7, 10, 8, 12, 10, 14, 12, 16, 14, 19, 16, 21, 19, 24, 21, 27, 24, 30, 27, 33, 30, 37, 33, 40, 37, 44, 40, 48, 44, 52, 48, 56, 52, 61, 56, 65, 61, 70, 65, 75, 70, 80, 75, 85, 80, 91, 85, 96, 91, 102, 96, 108, 102, 114, 108, 120
OFFSET
0,8
COMMENTS
a(n) is the number of triangles with integer sides and perimeter n.
Also a(n) is the number of triangles with distinct integer sides and perimeter n+6, i.e., number of triples (a, b, c) such that 1 < a < b < c < a+b, a+b+c = n+6. - Roger Cuculière
With a different offset (i.e., without the three leading zeros, as in A266755), the number of ways in which n empty casks, n casks half-full of wine and n full casks can be distributed to 3 persons in such a way that each one gets the same number of casks and the same amount of wine [Alcuin]. E.g., for n=2 one can give 2 people one full and one empty and the 3rd gets two half-full. (Comment corrected by Franklin T. Adams-Watters, Oct 23 2006)
For m >= 2, the sequence {a(n) mod m} is periodic with period 12*m. - Martin J. Erickson (erickson(AT)truman.edu), Jun 06 2008
Number of partitions of n into parts 2, 3, and 4, with at least one part 3. - Joerg Arndt, Feb 03 2013
For several values of p and q the sequence (A005044(n+p) - A005044(n-q)) leads to known sequences, see the crossrefs. - Johannes W. Meijer, Oct 12 2013
For n>=3, number of partitions of n-3 into parts 2, 3, and 4. - David Neil McGrath, Aug 30 2014
Also, a(n) is the number of partitions mu of n of length 3 such that mu_1-mu_2 is even and mu_2-mu_3 is even (see below example). - John M. Campbell, Jan 29 2016
For n > 1, number of triangles with odd side lengths and perimeter 2*n-3. - Wesley Ivan Hurt, May 13 2019
Number of partitions of n+1 into 4 parts whose largest two parts are equal. - Wesley Ivan Hurt, Jan 06 2021
For n>=3, number of weak partitions of n-3 (that is, allowing parts of size 0) into three parts with no part exceeding (n-3)/2. Also, number of weak partitions of n-3 into three parts, all of the same parity as n-3. - Kevin Long, Feb 20 2021
Also, a(n) is the number of incongruent acute triangles formed from the vertices of a regular n-gon. - Frank M Jackson, Nov 04 2022
REFERENCES
L. Comtet, Advanced Combinatorics, Reidel, 1974, p. 74, Problem 7.
I. Niven and H. S. Zuckerman, An Introduction to the Theory of Numbers. Wiley, NY, Chap.10, Section 10.2, Problems 5 and 6, pp. 451-2.
D. Olivastro: Ancient Puzzles. Classic Brainteasers and Other Timeless Mathematical Games of the Last 10 Centuries. New York: Bantam Books, 1993. See p. 158.
N. J. A. Sloane and Simon Plouffe, The Encyclopedia of Integer Sequences, Academic Press, 1995 (includes this sequence).
A. M. Yaglom and I. M. Yaglom: Challenging Mathematical Problems with Elementary Solutions. Vol. I. Combinatorial Analysis and Probability Theory. New York: Dover Publications, Inc., 1987, p. 8, #30 (First published: San Francisco: Holden-Day, Inc., 1964)
LINKS
Seiichi Manyama, Table of n, a(n) for n = 0..10000 (terms 0..1000 from T. D. Noe)
Alcuin of York, Propositiones ad acuendos juvenes, [Latin with English translation] - see Problem 12.
G. E. Andrews, A note on partitions and triangles with integer sides, Amer. Math. Monthly, 86 (1979), 477-478.
G. E. Andrews, MacMahon's Partition Analysis II: Fundamental Theorems, Annals Combinatorics, 4 (2000), 327-338.
G. E. Andrews, P. Paule and A. Riese, MacMahon's Partition Analysis IX: k-gon partitions, Bull. Austral Math. Soc., 64 (2001), 321-329.
G. E. Andrews, P. Paule and A. Riese, MacMahon's partition analysis III. The Omega package, p. 19.
Donald J. Bindner and Martin Erickson, Alcuin's Sequence, Amer. Math. Monthly, 119, February 2012, pp. 115-121.
P. Bürgisser and C. Ikenmeyer, Fundamental invariants of orbit closures, arXiv preprint arXiv:1511.02927 [math.AG], 2015. See Section 5.5.
James East and Ron Niles, Integer polygons of given perimeter, Bull. Aust. Math. Soc. 100 (2019), no. 1, 131-147.
James East and Ron Niles, Integer Triangles of Given Perimeter: A New Approach via Group Theory., Amer. Math. Monthly 126 (2019), no. 8, 735-739.
Wulf-Dieter Geyer, Lecture on history of medieval mathematics [broken link]
R. Honsberger, Mathematical Gems III, Math. Assoc. Amer., 1985, p. 39. [Annotated scanned copy]
T. Jenkyns and E. Muller, Triangular triples from ceilings to floors, Amer. Math. Monthly, 107 (Aug. 2000), 634-639.
J. H. Jordan, R. Walch and R. J. Wisner, Triangles with integer sides, Amer. Math. Monthly, 86 (1979), 686-689.
Hermann Kremer, Posting to de.sci.mathematik (1), (2), and (3). [Dead links]
Hermann Kremer, Posting to alt.math.recreational, June 2004.
N. Krier and B. Manvel, Counting integer triangles, Math. Mag., 71 (1998), 291-295.
Augustine O. Munagi, Computation of q-partial fractions, INTEGERS: Electronic Journal Of Combinatorial Number Theory, 7 (2007), #A25.
Simon Plouffe, Approximations de séries génératrices et quelques conjectures, Dissertation, Université du Québec à Montréal, 1992; arXiv:0911.4975 [math.NT], 2009.
Simon Plouffe, 1031 Generating Functions, Appendix to Thesis, Montreal, 1992
David Singmaster, Triangles with Integer Sides and Sharing Barrels, College Math J, 21:4 (1990) 278-285.
James Tanton, Young students approach integer triangles, FOCUS 22 no. 5 (2002), 4 - 6.
James Tanton, Integer Triangles, Chapter 11 in “Mathematics Galore!” (MAA, 2012).
Eric Weisstein's World of Mathematics, Alcuin's Sequence, Integer Triangle, and Triangle.
R. G. Wilson v, Letter to N. J. A. Sloane, date unknown.
FORMULA
a(n) = a(n-6) + A059169(n) = A070093(n) + A070101(n) + A024155(n).
For odd indices we have a(2*n-3) = a(2*n). For even indices, a(2*n) = nearest integer to n^2/12 = A001399(n).
For all n, a(n) = round(n^2/12) - floor(n/4)*floor((n+2)/4) = a(-3-n) = A069905(n) - A002265(n)*A002265(n+2).
For n = 0..11 (mod 12), a(n) is respectively n^2/48, (n^2 + 6*n - 7)/48, (n^2 - 4)/48, (n^2 + 6*n + 21)/48, (n^2 - 16)/48, (n^2 + 6*n - 7)/48, (n^2 + 12)/48, (n^2 + 6*n + 5)/48, (n^2 - 16)/48, (n^2 + 6*n + 9)/48, (n^2 - 4)/48, (n^2 + 6*n + 5)/48.
Euler transform of length 4 sequence [ 0, 1, 1, 1]. - Michael Somos, Sep 04 2006
a(-3 - n) = a(n). - Michael Somos, Sep 04 2006
a(n) = sum(ceiling((n-3)/3) <= i <= floor((n-3)/2), sum(ceiling((n-i-3)/2) <= j <= i, 1 ) ) for n >= 1. - Srikanth K S, Aug 02 2008
a(n) = a(n-2) + a(n-3) + a(n-4) - a(n-5) - a(n-6) - a(n-7) + a(n-9) for n >= 9. - David Neil McGrath, Aug 30 2014
a(n+3) = a(n) if n is odd; a(n+3) = a(n) + floor(n/4) + 1 if n is even. Sketch of proof: There is an obvious injective map from perimeter-n triangles to perimeter-(n+3) triangles defined by f(a,b,c) = (a+1,b+1,c+1). It is easy to show f is surjective for odd n, while for n=2k the image of f is only missing the triangles (a,k+2-a,k+1) for 1 <= a <= floor(k/2)+1. - James East, May 01 2016
a(n) = round(n^2/48) if n is even; a(n) = round((n+3)^2/48) if n is odd. - James East, May 01 2016
a(n) = (6*n^2 + 18*n - 9*(-1)^n*(2*n + 3) - 36*sin(Pi*n/2) - 36*cos(Pi*n/2) + 64*cos(2*Pi*n/3) - 1)/288. - Ilya Gutkovskiy, May 01 2016
a(n) = A325691(n-3) + A000035(n) for n>=3. The bijection between partition(n,[2,3,4]) and not-over-half partition(n,3,n/2) + partition(n,2,n/2) can be built by a Ferrers(part)[0+3,1,2] map. And the last partition(n,2,n/2) is unique [n/2,n/2] if n is even, it is given by A000035. - Yuchun Ji, Sep 24 2020
a(4n+3) = a(4n) + n+1, a(4n+4) = a(4n+1) = A000212(n+1), a(4n+5) = a(4n+2) + n+1, a(4n+6) = a(4n+3) = A007980(n). - Yuchun Ji, Oct 10 2020
a(n)-a(n-4) = A008615(n-1). - R. J. Mathar, Jun 23 2021
a(n)-a(n-2) = A008679(n-3). - R. J. Mathar, Jun 23 2021
EXAMPLE
There are 4 triangles of perimeter 11, with sides 1,5,5; 2,4,5; 3,3,5; 3,4,4. So a(11) = 4.
G.f. = x^3 + x^5 + x^6 + 2*x^7 + x^8 + 3*x^9 + 2*x^10 + 4*x^11 + 3*x^12 + ...
From John M. Campbell, Jan 29 2016: (Start)
Letting n = 15, there are a(n)=7 partitions mu |- 15 of length 3 such that mu_1-mu_2 is even and mu_2-mu_3 is even:
(13,1,1) |- 15
(11,3,1) |- 15
(9,5,1) |- 15
(9,3,3) |- 15
(7,7,1) |- 15
(7,5,3) |- 15
(5,5,5) |- 15
(End)
MAPLE
A005044 := n-> floor((1/48)*(n^2+3*n+21+(-1)^(n-1)*3*n)): seq(A005044(n), n=0..73);
A005044 := -1/(z**2+1)/(z**2+z+1)/(z+1)**2/(z-1)**3; # Simon Plouffe in his 1992 dissertation
MATHEMATICA
a[n_] := Round[If[EvenQ[n], n^2, (n + 3)^2]/48] (* Peter Bertok, Jan 09 2002 *)
CoefficientList[Series[x^3/((1 - x^2)*(1 - x^3)*(1 - x^4)), {x, 0, 105}], x] (* Robert G. Wilson v, Jun 02 2004 *)
me[n_] := Module[{i, j, sum = 0}, For[i = Ceiling[(n - 3)/3], i <= Floor[(n - 3)/2], i = i + 1, For[j = Ceiling[(n - i - 3)/2], j <= i, j = j + 1, sum = sum + 1] ]; Return[sum]; ] mine = Table[me[n], {n, 1, 11}]; (* Srikanth (sriperso(AT)gmail.com), Aug 02 2008 *)
LinearRecurrence[{0, 1, 1, 1, -1, -1, -1, 0, 1}, {0, 0, 0, 1, 0, 1, 1, 2, 1}, 80] (* Harvey P. Dale, Sep 22 2014 *)
Table[Length@Select[IntegerPartitions[n, {3}], Max[#]*180 < 90 n &], {n, 1, 100}] (* Frank M Jackson, Nov 04 2022 *)
PROG
(PARI) a(n) = round(n^2 / 12) - (n\2)^2 \ 4
(PARI) a(n) = (n^2 + 6*n * (n%2) + 24) \ 48
(PARI) a(n)=if(n%2, n+3, n)^2\/48 \\ Charles R Greathouse IV, May 02 2016
(PARI) concat(vector(3), Vec((x^3)/((1-x^2)*(1-x^3)*(1-x^4)) + O(x^70))) \\ Felix Fröhlich, Jun 07 2017
(Haskell)
a005044 = p [2, 3, 4] . (subtract 3) where
p _ 0 = 1
p [] _ = 0
p ks'@(k:ks) m = if m < k then 0 else p ks' (m - k) + p ks m
-- Reinhard Zumkeller, Feb 28 2013
CROSSREFS
See A266755 for a version without the three leading zeros.
Both bisections give (essentially) A001399.
(See the comments.) Cf. A008615 (p=1, q=3, offset=0), A008624 (3, 3, 0), A008679 (3, -1, 0), A026922 (1, 5, 1), A028242 (5, 7, 0), A030451 (6, 6, 0), A051274 (3, 5, 0), A052938 (8, 4, 0), A059169 (0, 6, 1), A106466 (5, 4, 0), A130722 (2, 7, 0)
Cf. this sequence (k=3), A288165 (k=4), A288166 (k=5).
Number of k-gons that can be formed with perimeter n: this sequence (k=3), A062890 (k=4), A069906 (k=5), A069907 (k=6), A288253 (k=7), A288254 (k=8), A288255 (k=9), A288256 (k=10).
KEYWORD
easy,nonn,nice
EXTENSIONS
Additional comments from Reinhard Zumkeller, May 11 2002
Yaglom reference and mod formulas from Antreas P. Hatzipolakis (xpolakis(AT)otenet.gr), May 27 2000
The reference to Alcuin of York (735-804) was provided by Hermann Kremer (hermann.kremer(AT)onlinehome.de), Jun 18 2004
STATUS
approved
Nonnegative integers repeated 3 times.
+10
122
0, 0, 0, 1, 1, 1, 2, 2, 2, 3, 3, 3, 4, 4, 4, 5, 5, 5, 6, 6, 6, 7, 7, 7, 8, 8, 8, 9, 9, 9, 10, 10, 10, 11, 11, 11, 12, 12, 12, 13, 13, 13, 14, 14, 14, 15, 15, 15, 16, 16, 16, 17, 17, 17, 18, 18, 18, 19, 19, 19, 20, 20, 20, 21, 21, 21, 22, 22, 22, 23, 23, 23, 24, 24, 24, 25
OFFSET
0,7
COMMENTS
Complement of A010872, since A010872(n) + 3*a(n) = n. - Hieronymus Fischer, Jun 01 2007
Chvátal proved that, given an arbitrary n-gon, there exist a(n) points such that all points in the interior are visible from at least one of those points; further, for all n >= 3, there exists an n-gon which cannot be covered in this fashion with fewer than a(n) points. This is known as the "art gallery problem". - Charles R Greathouse IV, Aug 29 2012
The inverse binomial transform is 0, 0, 0, 1, -3, 6, -9, 9, 0, -27, 81, -162, 243, -243, 0, 729,.. (see A000748). - R. J. Mathar, Feb 25 2023
LINKS
Václav Chvátal, A combinatorial theorem in plane geometry, Journal of Combinatorial Theory, Series B 18 (1975), pp. 39-41, doi:10.1016/0095-8956(75)90061-1.
Clark Kimberling, A Combinatorial Classification of Triangle Centers on the Line at Infinity, J. Int. Seq., Vol. 22 (2019), Article 19.5.4.
FORMULA
a(n) = floor(n/3).
a(n) = (3*n-3-sqrt(3)*(1-2*cos(2*Pi*(n-1)/3))*sin(2*Pi*(n-1)/3)))/9. - Hieronymus Fischer, Sep 18 2007
a(n) = (n - A010872(n))/3. - Hieronymus Fischer, Sep 18 2007
Complex representation: a(n) = (n - (1 - r^n)*(1 + r^n/(1 - r)))/3 where r = exp(2*Pi/3*i) = (-1 + sqrt(3)*i)/2 and i = sqrt(-1). - Hieronymus Fischer, Sep 18 2007; - corrected by Guenther Schrack, Sep 26 2019
a(n) = Sum_{k=0..n-1} A022003(k). - Hieronymus Fischer, Sep 18 2007
G.f.: x^3/((1-x)*(1-x^3)). - Hieronymus Fischer, Sep 18 2007
a(n) = (n - 1 + 2*sin(4*(n+2)*Pi/3)/sqrt(3))/3. - Jaume Oliver Lafont, Dec 05 2008
For n >= 3, a(n) = floor(log_3(3^a(n-1) + 3^a(n-2) + 3^a(n-3))). - Vladimir Shevelev, Jun 22 2010
a(n) = (n - 3 + A010872(n-1) + A010872(n-2))/3 using Zumkeller's 2008 formula in A010872. - Adriano Caroli, Nov 23 2010
a(n) = A004526(n) - A008615(n). - Reinhard Zumkeller, Apr 28 2014
a(2*n) = A004523(n) and a(2*n+1) = A004396(n). - L. Edson Jeffery, Jul 30 2014
a(n) = n - 2 - a(n-1) - a(n-2) for n > 1 with a(0) = a(1) = 0. - Derek Orr, Apr 28 2015
From Wesley Ivan Hurt, May 27 2015: (Start)
a(n) = a(n-1) + a(n-3) - a(n-4), n > 4.
a(n) = (n - 1 + 0^((-1)^(n/3) - (-1)^n) - 0^((-1)^(n/3)*(-1)^(1/3) + (-1)^n))/3. (End)
a(n) = (3*n - 3 + r^n*(1 - r) + r^(2*n)*(r + 2))/9 where r = (-1 + sqrt(-3))/2. - Guenther Schrack, Sep 26 2019
E.g.f.: exp(x)*(x - 1)/3 + exp(-x/2)*(3*cos(sqrt(3)*x/2) + sqrt(3)*sin(sqrt(3)*x/2))/9. - Stefano Spezia, Oct 17 2022
MAPLE
seq(i$3, i=0..100); # Robert Israel, Aug 04 2014
MATHEMATICA
Flatten[Table[{n, n, n}, {n, 0, 25}]] (* Harvey P. Dale, Jun 09 2013 *)
Floor[Range[0, 20]/3] (* Eric W. Weisstein, Aug 12 2023 *)
Table[Floor[n/3], {n, 0, 20}] (* ~~~ *)
Table[(n - Cos[2 (n - 2) Pi/3] + Sin[2 (n - 2) Pi/3]/Sqrt[3] - 1)/3, {n, 0, 20}] (* Eric W. Weisstein, Aug 12 2023 *)
Table[(n - ChebyshevU[n - 2, -1/2] - 1)/3, {n, 0, 20}] (* Eric W. Weisstein, Aug 12 2023 *)
LinearRecurrence[{1, 0, 1, -1}, {0, 0, 0, 1}, 20] (* Eric W. Weisstein, Aug 12 2023 *)
CoefficientList[Series[x^3/((-1 + x)^2 (1 + x + x^2)), {x, 0, 20}], x] (* Eric W. Weisstein, Aug 12 2023 *)
PROG
(PARI) a(n)=n\3 /* Jaume Oliver Lafont, Mar 25 2009 */
(Sage) [floor(n/3) for n in range(0, 79)] # Zerinvary Lajos, Dec 01 2009
(Haskell)
a002264 n = a002264_list !! n
a002264_list = 0 : 0 : 0 : map (+ 1) a002264_list
-- Reinhard Zumkeller, Nov 06 2012, Apr 16 2012
(PARI) v=[0, 0]; for(n=2, 50, v=concat(v, n-2-v[#v]-v[#v-1])); v \\ Derek Orr, Apr 28 2015
(Magma) [Floor(n/3): n in [0..100]]; // Vincenzo Librandi, Apr 29 2015
(Magma) &cat [[n, n, n]: n in [0..30]]; // Bruno Berselli, Apr 29 2015
CROSSREFS
Partial sums give A130518.
Cf. A004523 interlaced with A004396.
Apart from the zeros, this is column 3 of A235791.
KEYWORD
nonn,easy
STATUS
approved
Nonnegative integers repeated 4 times.
+10
100
0, 0, 0, 0, 1, 1, 1, 1, 2, 2, 2, 2, 3, 3, 3, 3, 4, 4, 4, 4, 5, 5, 5, 5, 6, 6, 6, 6, 7, 7, 7, 7, 8, 8, 8, 8, 9, 9, 9, 9, 10, 10, 10, 10, 11, 11, 11, 11, 12, 12, 12, 12, 13, 13, 13, 13, 14, 14, 14, 14, 15, 15, 15, 15, 16, 16, 16, 16, 17, 17, 17, 17, 18, 18, 18, 18, 19, 19, 19, 19
OFFSET
0,9
COMMENTS
For n>=1 and i=sqrt(-1) let F(n) the n X n matrix of the Discrete Fourier Transform (DFT) whose element (j,k) equals exp(-2*Pi*i*(j-1)*(k-1)/n)/sqrt(n). The multiplicities of the four eigenvalues 1, i, -1, -i of F(n) are a(n+4), a(n-1), a(n+2), a(n+1), hence a(n+4) + a(n-1) + a(n+2) + a(n+1) = n for n>=1. E.g., the multiplicities of the eigenvalues 1, i, -1, -i of the DFT-matrix F(4) are a(8)=2, a(3)=0, a(6)=1, a(5)=1, summing up to 4. - Franz Vrabec, Jan 21 2005
Complement of A010873, since A010873(n)+4*a(n)=n. - Hieronymus Fischer, Jun 01 2007
For even values of n, a(n) gives the number of partitions of n into exactly two parts with both parts even. - Wesley Ivan Hurt, Feb 06 2013
a(n-4) counts number of partitions of (n) into parts 1 and 4. For example a(11) = 3 with partitions (44111), (41111111), (11111111111). - David Neil McGrath, Dec 04 2014
a(n-4) counts walks (closed) on the graph G(1-vertex; 1-loop, 4-loop) where order of loops is unimportant. - David Neil McGrath, Dec 04 2014
Number of partitions of n into 4 parts whose smallest 3 parts are equal. - Wesley Ivan Hurt, Jan 17 2021
REFERENCES
V. Cizek, Discrete Fourier Transforms and their Applications, Adam Hilger, Bristol 1986, p. 61.
LINKS
J. H. McClellan and T. W. Parks, Eigenvalue and Eigenvector Decomposition of the Discrete Fourier Transform, IEEE Trans. Audio and Electroacoust., Vol. AU-20, No. 1, March 1972, pp. 66-74.
FORMULA
a(n) = floor(n/4), n>=0;
G.f.: (x^4)/((1-x)*(1-x^4)).
a(n) = (2*n-(3-(-1)^n-2*(-1)^floor(n/2)))/8; also a(n) = (2*n-(3-(-1)^n-2*sin(Pi/4*(2*n+1+(-1)^n))))/8 = (n-A010873(n))/4. - Hieronymus Fischer, May 29 2007
a(n) = (1/4)*(n-(3-(-1)^n-2*(-1)^((2*n-1+(-1)^n)/4))/2). - Hieronymus Fischer, Jul 04 2007
a(n) = floor((n^4-1)/4*n^3) (n>=1); a(n) = floor((n^4-n^3)/(4*n^3-3*n^2)) (n>=1). - Mohammad K. Azarian, Nov 08 2007 and Aug 01 2009
For n>=4, a(n) = floor( log_4( 4^a(n-1) + 4^a(n-2) + 4^a(n-3) + 4^a(n-4) ) ). - Vladimir Shevelev, Jun 22 2010
a(n) = A180969(2,n). - Adriano Caroli, Nov 26 2010
a(n) = A173562(n)-A000290(n); a(n+2) = A035608(n)-A173562(n). - Reinhard Zumkeller, Feb 21 2010
a(n+1) = A140201(n) - A057353(n+1). - Reinhard Zumkeller, Feb 26 2011
a(n) = ceiling((n-3)/4), n >= 0. - Wesley Ivan Hurt, Jun 01 2013
a(n) = (2*n + (-1)^n + 2*sin(Pi*n/2) + 2*cos(Pi*n/2) - 3)/8. - Todd Silvestri, Oct 27 2014
E.g.f.: (x/4 - 3/8)*exp(x) + exp(-x)/8 + (sin(x)+cos(x))/4. - Robert Israel, Oct 30 2014
a(n) = a(n-1) + a(n-4) - a(n-5) with initial values a(3)=0, a(4)=1, a(5)=1, a(6)=1, a(7)=1. - David Neil McGrath, Dec 04 2014
a(n) = A004526(A004526(n)). - Bruno Berselli, Jul 01 2016
From Guenther Schrack, May 03 2019: (Start)
a(n) = (2*n - 3 + (-1)^n + 2*(-1)^(n*(n-1)/2))/8.
a(n) = a(n-4) + 1, a(k)=0 for k=0,1,2,3, for n > 3. (End)
MAPLE
A002265:=n->floor(n/4); seq(A002265(n), n=0..100); # Wesley Ivan Hurt, Dec 10 2013
MATHEMATICA
Table[Floor[n/4], {n, 0, 100}] (* Wesley Ivan Hurt, Dec 10 2013 *)
Table[{n, n, n, n}, {n, 0, 20}]//Flatten (* Harvey P. Dale, Aug 08 2020 *)
PROG
(Sage) [floor(n/4) for n in range(0, 84)] # Zerinvary Lajos, Dec 02 2009
(PARI) a(n)=n\4 \\ Charles R Greathouse IV, Dec 10 2013
(Magma) [Floor(n/4): n in [0..80]]; // Vincenzo Librandi, Oct 28 2014
(Python)
def A002265(n): return n>>2 # Chai Wah Wu, Jul 27 2022
CROSSREFS
Zero followed by partial sums of A011765.
Partial sums: A130519. Other related sequences: A004526, A010872, A010873, A010874.
Third row of A180969.
KEYWORD
nonn,easy
STATUS
approved
a(n) = 6*n+3.
+10
95
3, 9, 15, 21, 27, 33, 39, 45, 51, 57, 63, 69, 75, 81, 87, 93, 99, 105, 111, 117, 123, 129, 135, 141, 147, 153, 159, 165, 171, 177, 183, 189, 195, 201, 207, 213, 219, 225, 231, 237, 243, 249, 255, 261, 267, 273, 279, 285, 291, 297, 303, 309, 315, 321, 327
OFFSET
0,1
COMMENTS
Apart from initial term(s), dimension of the space of weight 2n cuspidal newforms for Gamma_0(37).
Continued fraction expansion of tanh(1/3).
If a 2-set Y and a 3-set Z are disjoint subsets of an n-set X then a(n-4) is the number of 3-subsets of X intersecting both Y and Z. - Milan Janjic, Sep 08 2007
Leaves of the Odd Collatz-Tree: a(n) has no odd predecessors in all '3x+1' trajectories where it occurs: A139391(2*k+1) <> a(n) for all k; A082286(n)=A006370(a(n)). - Reinhard Zumkeller, Apr 17 2008
Let random variable X have a uniform distribution on the interval [0,c] where c is a positive constant. Then, for positive integer n, the coefficient of determination between X and X^n is (6n+3)/(n+2)^2, that is, A016945(n)/A000290(n+2). Note that the result is independent of c. For the derivation of this result, see the link in the Links section below. - Dennis P. Walsh, Aug 20 2013
Positions of 3 in A020639. - Zak Seidov, Apr 29 2015
a(n+2) gives the sum of 6 consecutive terms of A004442 starting with A004442(n). - Wesley Ivan Hurt, Apr 08 2016
Numbers k such that Fibonacci(k) mod 4 = 2. - Bruno Berselli, Oct 17 2017
Also numbers k such that t^k == -1 (mod 7), where t is a member of A047389. - Bruno Berselli, Dec 28 2017
LINKS
Friedrich L. Bauer, Der (ungerade) Collatz-Baum, Informatik Spektrum 31 (Springer, April 2008), pp. 379-384.
Tanya Khovanova, Recursive Sequences.
Luis Manuel Rivera, Integer sequences and k-commuting permutations, arXiv preprint arXiv:1406.3081 [math.CO], 2014.
William A. Stein, The modular forms database.
Eric Weisstein's World of Mathematics, Collatz Problem.
FORMULA
a(n) = 3*(2*n + 1) = 3*A005408(n), odd multiples of 3.
A008615(a(n)) = n. - Reinhard Zumkeller, Feb 27 2008
A157176(a(n)) = A103333(n+1). - Reinhard Zumkeller, Feb 24 2009
a(n) = 12*n - a(n-1) for n>0, a(0)=3. - Vincenzo Librandi, Nov 20 2010
G.f.: 3*(1+x)/(1-x)^2. - Mario C. Enriquez, Dec 14 2016
E.g.f.: 3*(1 + 2*x)*exp(x). - G. C. Greubel, Sep 18 2019
Sum_{n>=0} (-1)^n/a(n) = Pi/12 (A019679). - Amiram Eldar, Dec 10 2021
MAPLE
seq(6*n+3, n=0..60); # Dennis P. Walsh, Aug 20 2013
A016945:=n->6*n+3; # Wesley Ivan Hurt, Sep 29 2013
MATHEMATICA
Range[3, 350, 6] (* Vladimir Joseph Stephan Orlovsky, May 26 2011 *)
Table[6n+3, {n, 0, 60}] (* Wesley Ivan Hurt, Sep 29 2013 *)
LinearRecurrence[{2, -1}, {3, 9}, 55] (* Ray Chandler, Jul 17 2015 *)
CoefficientList[Series[3(1+x)/(1-x)^2, {x, 0, 60}], x] (* Robert G. Wilson v, Dec 14 2016 *)
PROG
(Haskell)
a016945 = (+ 3) . (* 6)
a016945_list = [3, 9 ..]
-- Wesley Ivan Hurt, Sep 29 2013
(Magma) [6*n+3 : n in [0..60]]; // Wesley Ivan Hurt, Sep 29 2013
(Maxima) makelist(6*n+3, n, 0, 60); /* Wesley Ivan Hurt, Sep 29 2013 */
(PARI) {a(n) = 6*n + 3} \\ Wesley Ivan Hurt, Sep 29 2013
(PARI) x='x+O('x^60); Vec(3*(1+x)/(1-x)^2) \\ Altug Alkan, Apr 08 2016
(Sage) [3*(1+2*n) for n in (0..60)] # G. C. Greubel, Sep 18 2019
(GAP) List([0..60], n-> 3*(1+2*n)); # G. C. Greubel, Sep 18 2019
CROSSREFS
Third row of A092260.
Subsequence of A061641; complement of A047263; bisection of A047241.
Cf. A000225. - Loren Pearson, Jul 02 2009
Cf. A020639. - Zak Seidov, Apr 29 2015
Odd numbers in A355200.
KEYWORD
nonn,easy
STATUS
approved
Number of partitions of n into 3 positive parts.
+10
82
0, 0, 0, 1, 1, 2, 3, 4, 5, 7, 8, 10, 12, 14, 16, 19, 21, 24, 27, 30, 33, 37, 40, 44, 48, 52, 56, 61, 65, 70, 75, 80, 85, 91, 96, 102, 108, 114, 120, 127, 133, 140, 147, 154, 161, 169, 176, 184, 192, 200, 208, 217, 225, 234, 243, 252, 261, 271, 280, 290, 300, 310, 320, 331, 341
OFFSET
0,6
COMMENTS
Number of binary bracelets of n beads, 3 of them 0. For n >= 3, a(n-3) is the number of binary bracelets of n beads, 3 of them 0, with 00 prohibited. - Washington Bomfim, Aug 27 2008
Also number of partitions of n-3 into parts 1, 2, and 3. - Joerg Arndt, Sep 05 2013
Number of incongruent triangles with integer sides that have perimeter 2n-3 (see the Jordan et al. link). - Freddy Barrera, Aug 18 2018
Number of ordered triples (x,y,z) of nonnegative integers such that x+y+z=n and x<y<z. A one-to-one correspondence between the ordered triples (x,y,z) defined above and the partitions (a,b,c) of n into 3 positive parts is shown by letting x=a-1 and letting z=c+1. - Dennis P. Walsh, Apr 19 2019
Number of incongruent triangles formed from any 3 vertices of a regular n-gon. - Frank M Jackson, Sep 11 2022
Also a(n-3) for n > 2, otherwise 0 is the number of incongruent scalene triangles formed from the vertices of a regular n-gon. - Frank M Jackson, Nov 27 2022
REFERENCES
Ross Honsberger, Mathematical Gems III, Math. Assoc. Amer., 1985, p. 39.
Donald E. Knuth, The Art of Computer Programming, vol. 4A, Combinatorial Algorithms, Section 7.2.1.4, p. 410.
Donald E. Knuth, The Art of Computer Programming, vol. 4,fascicle 3, Generating All Combinations and Partitions, Section 7.2.1.4., p. 56, exercise 31.
LINKS
Roland Bacher and P. De La Harpe, Conjugacy growth series of some infinitely generated groups, hal-01285685v2, 2016.
Nick Fischer and Christian Ikenmeyer, The Computational Complexity of Plethysm Coefficients, arXiv:2002.00788 [cs.CC], 2020.
Ross Honsberger, Mathematical Gems III, Math. Assoc. Amer., 1985, p. 39. [Annotated scanned copy]
J. H. Jordan, R. Walch and R. J. Wisner, Triangles with integer sides, Amer. Math. Monthly, 86 (1979), 686-689.
FORMULA
G.f.: x^3/((1-x)*(1-x^2)*(1-x^3)) = x^3/((1-x)^3*(1+x+x^2)*(1+x)).
a(n) = round(n^2/12).
a(n) = floor((n^2+6)/12). - Washington Bomfim, Jul 03 2012
a(-n) = a(n). - Michael Somos, Sep 04 2013
a(n) = a(n-1) + A008615(n-1) for n > 0. - Reinhard Zumkeller, Apr 28 2014
Let n = 6k + m. Then a(n) = n^2/12 + a(m) - m^2/12. Also, a(n) = 3*k^2 + m*k + a(m). Example: a(35) = a(6*5 + 5) = 35^2/12 + a(5) - 5^2/12 = 102 = 3*5^2 + 5*5 + a(5). - Gregory L. Simay, Oct 13 2015
a(n) = a(n-1) +a(n-2) -a(n-4) -a(n-5) +a(n-6), n>5. - Wesley Ivan Hurt, Oct 16 2015
a(n) = A008284(n,3). - Robert A. Russell, May 13 2018
a(n) = A005044(2*n) = A005044(2*n - 3). - Freddy Barrera, Aug 18 2018
a(n) = floor((n^2+k)/12) for all integers k such that 3 <= k <= 7. - Giacomo Guglieri, Apr 03 2019
From Wesley Ivan Hurt, Apr 19 2019: (Start)
a(n) = Sum_{k=1..floor(n/3)} Sum_{i=k..floor((n-k)/2)} 1.
a(n) = Sum_{i=1..floor(n/3)} floor((n-i)/2) - i + 1. (End)
Sum_{n>=3} 1/a(n) = 15/4 + Pi^2/18 - Pi/(2*sqrt(3)) + tanh(Pi/(2*sqrt(3))) * Pi/sqrt(3). - Amiram Eldar, Sep 27 2022
E.g.f.: (8*exp(-x/2)*cos(sqrt(3)*x/2) + (3*x^2 + 3*x - 8)*cosh(x) + (3*x^2 + 3*x + 1)*sinh(x))/36. - Stefano Spezia, Apr 05 2023
EXAMPLE
G.f. = x^3 + x^4 + 2*x^5 + 3*x^6 + 4*x^7 + 5*x^8 + 7*x^9 + 8*x^10 + 10*x^11 + ...
MAPLE
A069905 := n->round(n^2/12): seq(A069905(n), n=0..70);
MATHEMATICA
a[ n_]:= Round[ n^2 / 12] (* Michael Somos, Sep 04 2013 *)
CoefficientList[Series[x^3/((1-x)(1-x^2)(1-x^3)), {x, 0, 70}], x] (* Vincenzo Librandi, Oct 14 2015 *)
Drop[LinearRecurrence[{1, 1, 0, -1, -1, 1}, Append[Table[0, {5}], 1], 70], 2] (* Robert A. Russell, May 17 2018 *)
PROG
(PARI) a(n) = floor((n^2+6)/12); \\ Washington Bomfim, Jul 03 2012
(PARI) my(x='x+O('x^70)); concat([0, 0, 0], Vec(x^3/((1-x)*(1-x^2)*(1-x^3)))) \\ Altug Alkan, Oct 14 2015
(Haskell)
a069905 n = a069905_list !! n
a069905_list = scanl (+) 0 a008615_list
-- Reinhard Zumkeller, Apr 28 2014
(Magma) [(n^2+6) div 12: n in [0..70]]; // Vincenzo Librandi, Oct 14 2015
(GAP) List([0..70], n->NrPartitions(n, 3)); # Muniru A Asiru, May 17 2018
(SageMath) [round(n^2/12) for n in range(70)] # G. C. Greubel, Apr 03 2019
CROSSREFS
Another version of A001399, which is the main entry for this sequence.
Cf. A005044, A008284, A008615, A026810 (4 positive parts).
KEYWORD
nonn,easy
AUTHOR
N. J. A. Sloane, May 04 2002
STATUS
approved

Search completed in 0.054 seconds