ALGEBRAIC STRUCTURE OF THE MINIMAL SUPPORT CODEWORDS SET OF SOME LINEAR CODES. Irene Márquez-Corbella. Edgar Martínez-Moro

Size: px
Start display at page:

Download "ALGEBRAIC STRUCTURE OF THE MINIMAL SUPPORT CODEWORDS SET OF SOME LINEAR CODES. Irene Márquez-Corbella. Edgar Martínez-Moro"

Transcription

1 Volume X, No. 0X, 200X, X XX Web site: ALGEBRAIC STRUCTURE OF THE MINIMAL SUPPORT CODEWORDS SET OF SOME LINEAR CODES Irene Márquez-Corbella Dpto. Álgebra, Geometría y Topología Universidad de Valladolid, Castilla, Spain Edgar Martínez-Moro Dpto. Matemática Aplicada Universidad de Valladolid, Castilla, Spain (Communicated by the associate editor name) Abstract. It has been widely known that complete decoding for binary linear codes can be regarded as an linear integer programming problem with binary arithmetic conditions. Conti and Traverso [8] have proposed an efficient algorithm which uses Gröbner bases to solve integer programming with ordinary integer arithmetic conditions. Ikegami and Kaji [11] extended the Conti-Traverso algorithm to solve integer programming with modulo arithmetic conditions. It is natural to consider for those problems the Graver basis associated to them which turns to be the minimal cycles of the matroid associated to the code, i.e. minimal support codewords in the binary case and its geometry. This provides us an universal test set for the programs considered. 1. Introduction The sets of minimal support codewords in linear codes had been considered related to gradient-like decoding algorithms [1, 10]. Also there is interest to them due to the work of J. Massey in secret sharing schemes derived from linear codes [13], where minimal codewords describe the minimal access structures. It is quite dificult to describe the set of minimal codewords for an arbitrary linear code even in the binary case, in fact, the knowledge of the minimal codewords is related with the complete decoding problem which is a NP-problem [2] even if preprocessing is allowed [7]. The problem of determining the set of minimal codewords has been solved for q-ary Hamming codes and for the second order binary Reed-Muller codes and there has been attempts to characterize if for other classes of codes like BCH codes and the r th -order binary Reed-Muller code, see [6] and the references therein. From now on we will denote by Z, Z 0, R, Z q the integer numbers, the integers greater or equal to 0, the real numbers and the ring of integers modulo q respectively. The goal this paper is the use of Graver basis associated to modular linear program problems to describe the sets of codewords of minimal support codes defined on Z n q. The main tools will be combinatorial algebra techniques [17] related to linear integer programming addapted to the modular case. The outline of the paper is as follows. In section 2, we start by briefly reviewing the algorithm of Conti and Traverso, presented in [8], which shows the use Gröbner basis to solve integer 2000 Mathematics Subject Classification: Primary: 94B05, 13P25 ; Secondary:13P10. Key words and phrases: Minimal codewords, Modular/integer programming, Gröbner basis. The authors are partially supported by Spanish MCINN under project MTM c 200X AIMS-SDU

2 2 Irene Márquez-Corbella and Edgar Martínez Moro programming problems. The main idea of this algorithm is to compute a Gröbner basis of an ideal defined from the constrain equations and find the solution which minimizes the linear function using the Gröbner basis reduction. Then we discuss the extension of the Conti-Traverso algorithm given by Ikegami and Kaji [11] to solve linear integer programming with modulo arithmetic conditions. The reader should recall that the maximum likelihood decoding can be regarded as an linear integer programming with arithmetic conditions. In Section 3 we extend the work of [4] to the non-binary modular case. In [4] they introduce a binomial ideal derived from a binary lineal code C, which we prove that can be seen as the ideal associated to the kernel (over Z 2 ) of a modular linear integer programming problem. Finally, in section 4, we describe the set of codewords of minimal support of codes defined on Z n q using the Graver basis associated to an ideal. This Graver basis is again the Z q -kernel associated to a Lawrence lifted matrix so techniques on the previous section also apply to compute the set of minimal support codewords. It is important to recall that the modular integer programming approach in this paper does not allow to perform complete decoding in a straigth forward way for q > 2 as stated in Subsection 3.2 but the description of the Graver basis of the modular problem provides a description of the minimal support codewords set of linear codes over Z n q, see Subsection Integer-modular linear programs and Gröbner basis 2.1. Conti-Traverso algorithm. Given an integral matrix A Z m n, which is known as the matrix of coefficients, and the vectors b Z m and w R n, the vector w is called the cost vector, the integer linear programming problem, denoted by IP A,w (b) consists of three parts: a linear function to be minimized, a problem constraints and non-negative variables. Therefore if we expresse the problem in matrix form it becomes: minimize w { u (1) IP A,w (b) = Au subject to t = b u Z n 0 A solution u Z n 0 which satisfied Aut = b is called optimal if u minimizes the inner product w u. Although an integer program differs from a linear program only in the requirement that solutions are integral instead of real, the general integer program is NP-complete while linear programs can be solved in polynomial time. The first general algorithm to solve an integer program was Gomory s cutting plane method, then further methods around branching and bounding integer linear programs were designed. For other algorithms and further reading on both linear and integer programming see [16]. In [8] Conti and Traverso introduced a Gröbner basis based algorithm to solve IP A,w as follows. Every u Z n can be written uniquely as u = u + u where u +, u Z n 0 and have disjoint supports where the support of a vector u Zn is the set supp(u) = {i u i 0} {1,..., n}. For a given integer linear programming problem IP A,w stated as in Equation (1) the algorithm computes a reduced Gröbner basis G w of the toric ideal I = {x u+ x u u ker Z (A)} w.r.t the term order w induced by the cost vector w R n and defined as: { either w α w β or α w β w α = w β, α β, for a fixed admisible ordering.

3 Algebraic structure of the minimal support codewords set 3 Note that the reduced Gröbner basis of the binomial ideal I is given also by binomials (see [17], Corolary 4.4 for a proof). Finally, for any non-optimal solution u of IP A,w (b), we compute the normal form of the monomial x u w.r.t. G w namely nf G w (x u ) = x u, and then u is the optimal solution. The interested reader can refer to [17] for an account on Gröbner basis material related to integer linear programming. A test set for the family of problems IP A,w is a subset T w ker Z (A) if, for each non-optimal solution u to a program IP A,w (b), there exists t T w such that u t is also a solution and t w 0. The binomials involved in the reduced Gröbner basis G w induce a uniquely defined test set for IP A,w called the Gröbner basis test set. The existence of a finite test set T w gives a trivial gradient descent method for finding the optimal solution of the problem IP A,w (b). Indeed, starting at a solution u of IP A,w (b) we can successively move to an improved solution of the program by subtracting an appropriate element of T w, then the solution u is optimal if, and only if, there does not exists t T w such that u t is feasible for IP A,w (b) Modular linear programming. Ikegami and Kaji in [11] adapted the ideas of the Conti-Traverso algorithm to solve the modular integer programming problem. Let us consider the integer q 2, from now on we will use the following characteristic crossing functions : (2) : Z s Z s q and : Z s q Z s where s is determined by context and the spaces may also be matrix spaces. The map is reduction modulo q, but the map replaces the class of 0, 1,..., q 1 by the same symbols regarded as integers, both maps act coordinatewise. These maps will be used with matrices and vectors, themselves regarded as maps, acting on the right. and the vectors b Z m q, w R n, we define a modular integer program, denoted by IP A,w,q (b) as the problem of finding a vector u Z n q that minimizes the inner product w u subject to Au t b mod q. If we expressed the problem in matrix form it becomes: Consider the matrix A Z m n q (3) IP A,w,q (b) = minimize w { u Au subject to t b mod q u Z n q Note that the constrain conditions are a modular ones but the weight minimizing condition is over the reals. Let x denote n variables x 1,..., x n and y denote m variables y 1,..., y m, consider the ring homomorphism Θ defined by (4) Θ : K[x] K[y] x v Θ(x v ) = y ( A)vt. Let J q be a binomial ideal defined by J q = {y q i 1}m i=1 in the polynomial ring K[y]. We have the following result. Lemma 2.1 ([11], Lemma 1). Au t b mod q if and only if Θ(x u ) y b mod J q. In [11] they showed that the ideal generated by the binomials associated to the vectors belonging to the Z q -kernel of the matrix A, which is the kernel of the ring

4 4 Irene Márquez-Corbella and Edgar Martínez Moro homomorphism Θ, is given by the elimination ideal I = I A K[x] where (5) I A = {φ i x i } n i=1, {y q j 1}m K[x, y], and φi = Θ(x i ) = m y ai,j j. Remark 1. In other words, we can see the ideal related to the the Z q -kernel of A as an elimination ideal of the ideal related to the Z-kernel of the matrix ( A, q I m ) Z m (m+n). The following lemma gives the characterization of the polynomials that belong to the ideal I A. Necessary condition was already stated in [11], we show it here again for completenesses. Lemma 2.2. f I A K[x] if and only if f K[x] and Θ(f) 0 mod J q. Proof. Let f I A, by representing f with the generators of I A, thus f(x, y) = n i=1 λ i(φ i x i ) + m β j(y q j 1) where λ 1,..., λ n, β 1,..., β m K[x, y]. Then Θ(f) = f(θ(x 1 ),..., Θ(x n ), y 1,..., y m ) = n m Θ(λ i ) (φ i Θ(x i )) + Θ(β j )(y q j 1) = i=1 m Θ(β j )(y q j 1) 0 mod J q. To prove the converse, first note that given u Z n q a monomial x u = x u1 1 xun n with can be written, for some B 1,... B n K[x, y] as: x u1 1 xun n = (φ 1 + (x 1 φ 1 )) u1 (φ n + (x n φ n )) un = φ u1 1 φun n + B 1 (x 1 φ 1 ) +... B n (x n φ n ). Thus, there exist polynomials C 1,..., C n K[x, y], f K[x] such that f(x) = f(φ 1,..., φ n ) + n i=1 C i(x i φ i ). From the initial assumption we have Θ(f) = f(θ(x 1 ),..., Θ(x n )) = f(φ 1,..., φ n ) 0 mod J q, therefore f(x 1,..., x n ) = f(φ 1,..., φ n ) }{{} J q I A + n C i (x i φ i ) I A. i=1 } {{ } I A A monomial order w on K[x, y] is adapted to the problem IP A,w,q (b) if it is an elimination order for K[x] and it is compatible with w, i.e. for any u, v Z n q such that Θ(x u ) Θ(x v ) mod J q ( i.e. y (Aut) y (Avt ) mod J q ) if w u w v then x u w x v. Consider G w a Gröbner basis of the ideal I A w.r.t. an adapted monomial order w then the Conti-Traverso algorithm is extended to the modular case as follows: Theorem 2.3 ([11], Theorem 6). Given the monomial x b and let the normal form w.r.t. G w be nf G w (x b ) = x u, then u will give an optimal solution of the problem IP A,w,q (b).

5 Algebraic structure of the minimal support codewords set 5 3. Describing the kernel in K[x] Note that in the previous description one requires m n variables for describing the elimination ideal I A K[x] which is in the ambient space K[x] which involves n variables only. Therefore in order to improve the eficiency it is desirable that the whole computation would be inside K[x]. Di Biase and Urbanke [9] developed some ideas concerning this problem for the integer Z-kernel related to the problem IP A,w (b) in Equation (1). We will describe in this section how to compute the Z q -kernel of the problem IP A,w,q (b) in Equation (3) considering only computations in K[x]. Let A Zq k n be a matrix, we will define the following ideal (6) I(A) = {x u1 x u2 A (u 1 u 2 ) 0 mod q} i.e. all the binomials such that (u 1 u 2 ) is in the modular kernel ker Zq (A). If we consider the linear subespace {u Z n q u a = 0, a row ofa} and A be a matrix whose rows generate such linear subespace The following proposition is an extension of Proposition 1 of [4]. Proposition 3.1. Let {w 1,..., w k } Z n q a set of generators of the row space of the matrix A Z k n q and consider any vector a, b Z n. The following conditions are equivalent: 1. A a A b mod q, 2. x a x b I(A ). 3. t 1, t 2 K[x] and λ 1,..., λ k Z n such that s (7) x a+(q 1)b t q 1 = tq 2 x λi wj. Proof. First we will see the equivalence between 1. and 2. By Lemma 2.2, x a x b belongs to I(A ) if, and only if, Θ(x a x b ) 0 mod J q. Thus y ( A) a y ( A) b mod J q. By Lemma 2.1 this holds if and only if A a A b mod q. Let us define the homomorphism Φ from K[x] to Z n q as Φ : K[x] Z n q x a Φ(x a ) = (( a 1 ),..., ( a n )). It is easy to see that for all a, b Z n the two following properties hold: (8) Φ(x a ) = Φ(x b ) t 1, t 2 K[x] such that t q 1 xa = t q 2 xb. Φ(x a ) Φ(x b ) = Φ(x a ) + (q 1)Φ(x b ) = Φ(x a+(q 1)b ). Furthermore x a x b I(A ) if and only if Φ(x a ) Φ(x b ) belongs to the vector space generated by the set of vectors {w 1,... w k }, since x a x b I(A ) A (a b) 0 mod q, i.e. (a b) {w 1,..., w k } If x a x b I(A ) we have that Φ(x a ) Φ(x b ) = Φ(x a+(q 1)b ) = k i=1 λ q,iw i = Φ( k i=1 x λq,i wi ) where λ q,i Z n q i = 1,..., k. Let λ q,i = λ i i = 1,..., k, by Equation 8, there exist t 1, t 2 K[x] such that t q 1 xa+(q 1)b = t q 2 k i=1 xλi wi If there exist t 1, t 2 K[x] and λ 1,..., λ k Z n such that t q 1 xa+(q 1)b = t q k 2 i=1 xλi wi then Φ(x a ) Φ(x b ) = Φ(x a+(q 1)b ) = Φ( k i=1 xλi wi ) = k i=1 λ iw i

6 6 Irene Márquez-Corbella and Edgar Martínez Moro and we may conclude that the vector Φ(x a ) Φ(x b ) is a linear combination of the set {w 1,..., w k }, that is x a x b I(A ). Let us define the following ideal (9) I = {x w1 1,..., x w k 1} {x q i 1}n i=1 K[x] Theorem 3.2. I = I(A ) = I A K[x]. Proof. It is clear that I I(A ) since all binomials in the generating set of I belong to I(A ). To show the converse it is enough to prove that any binomial x a x b of I(A ) belongs to I. Notice that by Proposition 3.1, there exist t 1, t 2 K[x] and λ 1,..., λ k Z n such that x a+(q 1)b t q 1 = s tq 2 xλj wj. If z 1 1, z 2 1 I, since z 1 z 2 1 = (z 1 1) z 2 + (z 2 1), we have z 1 z 2 1 I. Therefore k i=1 1 I and x wi k k x λj wj 1 = x wj 1 x (λj 1) wj + x (λj 1) wj 1 k =... = x wj 1 j λ j>0 j λ j>0 j λ j>0 x (λj 1) wj j λ j>0 x wj 1 This implies that t q 1 xa+(q 1)b 1 = t q 2 k xλj wj 1 I. Since x a x b = x b (x a+(q 1)b 1) x a (x qb 1) I, we may conclude that I(A ) = I. Now we will show that I = I A K[x]. First we notice that Θ(x wi 1) = 0 (since A A = 0) and Θ(x q i 1) = Θ(xqei 1) = y ( (A ))(qe i) 1 j a ij 0 B j(y q j 1) 0 mod J q where ( A ) = (a ij ) Zm n, B j K[y] and e i represent the ith-unit vector of the standard basis of Z n. Therefore by Lemma 2.2 it follows that any binomial in the generating set of I belongs to I A K[x]. On the other hand, since I A K[x] is a binomial ideal it is generated by binomials. Let us consider a binomial f = x u x v I A K[x] with u, v Z n 0. Lemma 2.2 implies that Θ(f) = y ( A )u t y ( A )v t 0 mod J q. Furthermore, by Lemma 2.1 we have that A u A v mod q, hence by Proposition 3.1, we conclude that f I(A ) = I. Remark 2. Note that the matrix A plays the role of the non negative matrix that Di Biase and Urbanke look for in their paper, thus the previous theorem can be seen as a generalization of the setting in [9] for getting rid of the variables concerning y in I A Computing the Gröbner basis. In order to carry out Conti-Traverso procedure we must compute a reduced Gröbner basis of I A K[x]. Note that we know a set of generators of the ideal I A K[x] given by {x w1 1,..., x w k 1} {x q i 1}n i=1 thus for computing a reduced Gröbner basis G w.r.t. a degree compatible order we can use the FGLM-based trick in [4]. In that paper it is stated for the binary case, but the generalization to the modulo q is straight forward. We just point out the main idea and advantages of the algorithm, the interested reader can look at [4] for a detailed description of the algorithm and its complexity issues.

7 Algebraic structure of the minimal support codewords set 7 The idea is the following, given a set of generators {f 1, f 2,..., f r } of the ideal I A K[x] notice that each syzygy in K[x] r+1 with generator set F = { 1, f 1,..., f r } points to an element in the ideal. Now consider the syzygies (f 1, 1, 0, 0,..., 0),..., (f r, 0, 0, 0,..., 1). They are a Gröbner basis of the syzygy module w.r.t. a position over term (POT) ordering induced from an ordering < in K[x] and the weight vector (1, T < (f 1 ),..., T < (f r )). Now we use the FGLM idea and run through the terms of K[x] r+1 in adequate term over position (TOP) ordering that reveals the Gröbner basis of the ideal in the first component. The above procedure is completely general, in our setting it has the following advantages: (i) Note that the total degree of the binomials involved is bounded by n q, moreover the degree of each variable is at most q since the binomials {x q i 1}n i=1 belong to the ideal. (ii) We can encode all the information of the problem in the exponents, thus we can always take K = F 2 even if q 2. (iii) All the steps can be carried out as Gaussian elimination steps. The two first items above make the most common drawbacks of Gröbner basis computation fail, namely growth of the total degree and growth of coefficients Complete decoding. To end this section we review the relation of this approach with the complete decoding problem in the binary case. Let q = 2 and H be the parity check matrix of a linear code over Z 2. Then solving the modular program IP H,1,2 (b) where 1 = (1, 1,..., 1) is equivalent to complete decoding b. This is the approach in [11] and we have just shown by Theorem 3.2 above that (only in the binary case) it is equivalent to the approach in [4]. It must be noticed that the reduced Gröbner basis associated to the problem provides us a (minimal) test set T whose elements are binomials associated to minimal codewords. Thus, this complete decoding scheme is equivalent to the gradient descent decoding given by Barg [1] and proven to be equivalent to Liebler approach [12], see [4] for a proof. Unfortunately, Hamming metric can not be stated as a linear programming objective for q > 2, i.e. min {w u} min {w(u)} where w denotes the Hamming weight. In [5] avoided the problem above for q = p r (p a prime) by using some non-admisible but noetherian-confluent orderings and substituting Gröbner basis by Border basis. 4. Minimal support codewords set As stated in the previous subsection, modular integer programming approach in this paper does not allow to perform complete decoding in a straigth forward way for q > 2. We shall prove in this section that this approach allow us to describe the set of minimal support codewords of a code which will be related to the Graver basis of the modular integer program. The main tool for computing such a Graver basis will be a Gröbner basis computation that again will be well suited for an extended algorithm in [4] showed in Subsection Graver basis. Given an integer matrix A Z m n we define the universal Gröbner basis UGB A as the union of all reduced Gröbner basis for every generic weight w. A binomial x u+ x u I A is primitive if there exists no other binomial x v+ x v I A such that x v+ divides x u+ and x v divides x v. In other words, an integral vector u ker Z (A) is said to be primitive if the greatest common divisor of the components of the corresponding binomial (+ ve and ve) is 1. We call the set of primitive binomials in I A the Graver basis of A and denote it by Gr A ker Z (A).

8 8 Irene Márquez-Corbella and Edgar Martínez Moro A circuit of A is a non-zero primitive vector u ker Z (A) such that its support is minimal. If we denote C A the set of circuits of A, we have that C A UGB A Gr A (see [17], Proposition 4.11 for a proof). Definition 4.1. The lattice L(A) = {x Z n Ax = 0} has a natural partial order. For u, v Z n we say that u is conformal to v, denoted u v if u i v i and u i v i > 0 for all i = 1,..., n That is, u and v lie in the same orthant of R n and each component of u is bounded by the corresponding component of v in absolute value. Note that the binomial x u+ x u in I A is primitive if the vector u = u + u Z n is minimal with respect to the order. Thus the Graver basis of an integer matrix A is the set of conformal-minimal nonzero integer dependencies on A. A set U A ker Z (A) is an universal test set for IP A if U A contains a test set for the family of integer programs IP A,w for every generic w. The Graver basis Gr A and the universal Gröbner basis UGB A of A are universal test set for A. Another way of looking at Graver basis is the following. For each σ {+, } consider the semigroup S σ = ker Z (A) R n σ where Rσ n is the orthant with sign pattern σ. We have a pointed polyhedral cone in R n { } pos(s σ ) = λi x i x i S σ, λ i > 0 Pointed cones have a unique Hilbert basis H σ. Graver showed that Gr A := σ H σ \ {0} is a universal test set for IP A Lawrence Lifting. The Lawrence lifting of the matrix A Z m n is the enlarged matrix ( ) A 0m n Λ(A) = Z (m+n) 2n I n I n Where I n Z n n is the n-identity matrix and 0 m n Z m n is the all zero matrix. The matrices A and Λ(A) have isomorphic kernels ker Z (Λ(A)) = {(u, u) u ker Z (A)} and the toric ideal I Λ(A) is an homogeneous prime ideal defined as (10) I Λ(A) = x u+ z u x u z u+ u ker(a) K[x, z] where z represents the variables z 1, z 2,..., z n. Theorem 4.2 (Sturmfels-Thomas, 1998, [17] Theorem 7.1). For the matrix Λ(A) the following sets coincide: 1. The Graver basis of Λ(A). 2. The universal Gröbner basis of Λ(A). 3. Any reduced Gröbner basis of Λ(A). 4. Any minimal generating set of Λ(A) (up to scalar multiples). Theorem 4.2 above suggest the following algorithm for computing a Graver basis of A. Choose any term order on K[x, z] and compute a reduced Gröbner basis of Λ(A), by Theorem 4.2, any reduced Gröbner basis of Λ(A) is also a Graver basis of Λ(A). Thus for each element in the Graver basis x α z β x β z α, the element x α x β belongs to the Graver basis of A. Now let us consider the matrix A Z m n q, in a similar fashion we can consider the Lawrent lifting for the modulo q of the matrix A as ( ) A 0q,m n Λ(A) q = Z I q,n I q (m+n) 2n q,n

9 Where I q,n Z n n q matrix. Algebraic structure of the minimal support codewords set 9 is the n-identity matrix and 0 q,m n Z m n q is the all zero Remark 3. Note that again, as pointed in Remark 1 we can see the ideal related to the the Z q -kernel of Λ(A) q as an elimination ideal of the ideal related to the Z-kernel of the matrix ( A ) 0m n q I m Z (m+n) (2n+m). I n I n 0 n m Then we have a similar result to that in the previous theorem relating the Z q - kernel of A and the kernel of Λ(A) q (see [11, Theorem 8]). In order to to compute the Gaver basis note that again we can use the modified version of the FGLM-like algorithm in order to compute ker Zq (Λ(A) q ) Minimal support codewords set. We will consider a linear code over the alphabet Z q of length n and dimension n k as linear subspace C Z n q. The elements of C are call codewords and for a c C we define the support of c = (c 1,..., c n ) as its support as a vector, i.e. supp(c) = {i c i 0}. Let H C be the parity check with parity check matrix of C. We will say that a codeword m has minimal support or that it is a minimal support codeword if it is non-zero and supp(m) is not contained in the supports of any other codewords. We have the following easy result Lemma 4.3. Two minimal support codewords in C Z n q with the same support should be one scalar multiple of the other. Proof. Suppose that m = (m 1,..., m n ) C is a minimal support codeword and there is a m i 0 i {1,..., n} and such that αm i = 0 where 0 α Z q, then αm C and supp(αm) supp(m) which contradices the minimality of m unless αm = 0. Thus either all its non-zero entries must be units in Z q or all of them are non units. Moreover, if all its non-zero entries are non units they must be equal since if there are two of them different 0 m i1 m i2 0 we can suppose w.l.g. that m i1 < m i2, take β = q m i2 then βm is a non-zero codeword with supp( βm) supp(m) which contradices the minimality. Now consider the case where all its non-zero entries are units in Z q and let m = (m 1,..., m n) be also a minimal support codeword with supp(m) = supp(m ) and let m i, m i two non zero entries of m, m respectively, thus they are units and c = m mi m m C. Since supp(c) supp(m) and m is a minimal support codeword i then m mi m m = 0 and the result holds. i We will define a set of codewords of minimal support of the code as a set containing a representative of all the minimal support codewords of the code modulo scalar multiplication. Theorem 4.4. A Graver basis of H C a parity check matrix of C gives us a set of codewords of minimal support of the code C Z n q. Proof. Let m be a codeword of minimal support of the code C and Gr HC the Graver basis of H C. Assume that m / Gr HC, this implies that the binomial x m+ x m is not primitive. Hence there exists a binomial x u+ x u such that u m, contradicting the fact that m has minimal support. The previous result gives us a procedure to compute the set of minimal supports of codes defined on Z q, in particular for codes over F p with p prime, but not for the

10 10 Irene Márquez-Corbella and Edgar Martínez Moro case p r since F p r Z p r. In the binary case the set of codewords of minimal support of the code are all minimal codewords, we have C A = UGB A = Gr A, the cases when this equality holds and the obstructions for this property in the non modular case are studied by Bogart, Jensen and Thomas [3]. Now the two following corollaries are straigth forward Corollary 4.5. Let C Z n q be a linear code and H C a parity check matrix of C, then the set of minimal support codewords of the code C is the projection on the first n coordinates of the set (11) {w w = (v, (q 1) v) T } where T is a Gröbner test set of the integer modular linear program with associated matrix ( ) HC 0. I n I n Corollary 4.6. The minimal codewords of C can be computed from the ideal (12) {x w1 z w1(q 1) 1,..., x w k z wk(q 1) 1} {x q i 1}n i=1 {z q i 1}n i=1 where w i for i = 1,..., k are the rows of a generator matrix of C. Example 4.7 (Toy example). Consider H F 7 2 the [7, 4, 3] Hamming code over F 2. It has 16 codewords of weights 0, 3, 4, 7. All the 14 codewords of weight 3 or 4 we are minimal and the only non minimal codewords are 0 and 1. If we compute the Gröbner test set for H w.r.t. a degree reverse lexicographic ordering we get the following Gröbner basis {x 3 x 7 + x 1, x 1 x 7 + x 3, x 5 x 6 + x 1, x 4 x 6 + x 3, x 3 x 6 + x 4, x 2 x 6 + x 7, x 1 x 6 + x 5, x 4 x 5 + x 7, x 3 x 5 + x 2, x 2 x 5 + x 3, x 1 x 5 + x 6, x 3 x 4 + x 6, x 2 x 4 + x 1, x 1 x 4 + x 2, x 2 x 3 + x 5, x 1 x 3 + x 7, x 1 x 2 + x 4 } {x 2 i 1}7 i=1 which gives us the 7 minimal codewords of weight 3 (0, 1, 0, 0, 0, 1, 1), (1, 0, 1, 0, 0, 0, 1), (1, 1, 0, 1, 0, 0, 0), (0, 1, 1, 0, 1, 0, 0), (0, 0, 1, 1, 0, 1, 0), (1, 0, 0, 0, 1, 1, 0), (0, 0, 0, 1, 1, 0, 1). The degree reverse lexicographic Gröbner basis of the Lawrence lifting used for computing the Graver basis has 155 elements representing the 7 words already in the Gröbner test set plus the 7 minimal codewords of weight 4. (0, 1, 0, 1, 1, 1, 0), (1, 0, 1, 1, 1, 0, 0), (1, 1, 1, 0, 0, 1, 0), (0, 1, 1, 1, 0, 0, 1), (1, 1, 0, 0, 1, 0, 1), (1, 0, 0, 1, 0, 1, 1), (0, 0, 1, 0, 1, 1, 1) Acknowledgements We would like to thank A. Vigneron for his valuable comments and suggestions. In fact some of the ideas behind modulo q integer programs are closely related to the ideas in Vigneron-Pisón s paper [15] when considering semigroups with q-torsion. References [1] A. Barg, Complexity issues in coding theory, In Handbook of Coding Theory, Elsevier Science, 1, (1998), [2] E.R. Berlekamp, R.J. McEliece, H.C.A. van Tilborg, On the Inherent Intractability of Certain Coding Problems IEEE Trans. Inform. Theory, IT-24, no. 3, (1978), [3] T. Bogart, A.N. Jensen and R.R. Thomas, The circuit ideal of a vector configuration, J. Algebra 308 (2007), no. 23,

11 Algebraic structure of the minimal support codewords set 11 [4] M. Borges-Quintana, M.A. Borges-Trenard, P. Fitzpatrick and E. Martínez-Moro, Gröbner bases and combinatorics for binary codes, Appl. Algebra Engrg. Comm. Comput. 19 (2008), no. 5, [5] M. Borges-Quintana, M.A. Borges-Trenard and E. Martínez-Moro, A Gröbner bases structure associated to linear codes, J. Discrete Math. Sci. Cryptogr. 10 (2007), no. 2, [6] Y. Borissov, N. Manev, Nickolai Minimal codewords in linear codesserdica Math. J. 30 no. 2-3, (2004), [7] J. Bruck, M. Naor, The Hardness of Decoding Linear Codes with Preprocessing, IEEE Trans. Inform. Theory 36, no. 2, (1990) [8] P. Conti and C. Traverso, Buchberger algorithm and integer programming, Applied algebra, algebraic algorithms and error-correcting codes (New Orleans, LA, 1991), Lecture Notes in Comput. Sci. 539 (1991), [9] F. Di Biase and R. Urbanke, An algorithm to calculate the kernel of certain polynomial ring homomorphisms, Experiment. Math. 4 (1995), no. 3, [10] T.Y. Hwang, Decoding linear block codes for minimizing word error rate, IEEE Trans. Inform. Theory 25 (1979), [11] D. Ikegami and Y. Kaji, Maximum likelihood decoding for linear block codes using Gröbner bases, IEICE Trans. Fund. Electron. Commun. Comput. Sci. E86-A, 3 (2003) [12] R. Liebler,Implementing gradient descent decoding,michigan Math. J. 58, Issue 1 (2009), [13] J. L. Massey. Minimal Codewords and Secret Sharing, Proceedings of the 6th Joint Swedish- Russian International Workshop on Information Theory (1993), [14] H. Ohsugi,, D. Ikegami, T. Kitamura and T. Hibi, Gröbner bases bases of certain zerodimensional ideals arising in coding theory, Adv. in Appl. Math., 31 (2003) no. 2, [15] P. Pisón-Casares and A. Vigneron-Tenorio, On Lawrence semigroups Journal of Symbolic Computation, 43 (2008), [16] A. Schrijver, Theory of Linear and Integer Programming Wiley-Interscience, (1996). [17] B. Sturmfels, Gröbner bases bases and Convex Polytopes University Lecture Series, 8, American Mathematical Society, Providence, RI, (1996). Received April 2010; revised??. address: imarquez@agt.uva.es address: edgar@maf.uva.es

Toric Ideals, an Introduction

Toric Ideals, an Introduction The 20th National School on Algebra: DISCRETE INVARIANTS IN COMMUTATIVE ALGEBRA AND IN ALGEBRAIC GEOMETRY Mangalia, Romania, September 2-8, 2012 Hara Charalambous Department of Mathematics Aristotle University

More information

Groebner Bases, Toric Ideals and Integer Programming: An Application to Economics. Tan Tran Junior Major-Economics& Mathematics

Groebner Bases, Toric Ideals and Integer Programming: An Application to Economics. Tan Tran Junior Major-Economics& Mathematics Groebner Bases, Toric Ideals and Integer Programming: An Application to Economics Tan Tran Junior Major-Economics& Mathematics History Groebner bases were developed by Buchberger in 1965, who later named

More information

Error-correcting Pairs for a Public-key Cryptosystem

Error-correcting Pairs for a Public-key Cryptosystem Error-correcting Pairs for a Public-key Cryptosystem Ruud Pellikaan g.r.pellikaan@tue.nl joint work with Irene Márquez-Corbella Code-based Cryptography Workshop 2012 Lyngby, 9 May 2012 Introduction and

More information

Arrangements, matroids and codes

Arrangements, matroids and codes Arrangements, matroids and codes first lecture Ruud Pellikaan joint work with Relinde Jurrius ACAGM summer school Leuven Belgium, 18 July 2011 References 2/43 1. Codes, arrangements and matroids by Relinde

More information

21073 Hamburg, GERMANY

21073 Hamburg, GERMANY International Journal of Pure and Applied Mathematics Volume 91 No. 2 2014, 155-167 ISSN: 1311-8080 (printed version); ISSN: 1314-3395 (on-line version) url: http://www.ijpam.eu doi: http://dx.doi.org/10.12732/ijpam.v91i2.2

More information

arxiv: v2 [math.ac] 19 Dec 2008

arxiv: v2 [math.ac] 19 Dec 2008 A combinatorial description of monomial algebras arxiv:0810.4836v2 [math.ac] 19 Dec 2008 Ignacio Oeda Universidad de Extremadura Departamento de Matemáticas e-mail: oedamc@unex.es March 22, 2009 Abstract

More information

A decoding algorithm for binary linear codes using Groebner bases

A decoding algorithm for binary linear codes using Groebner bases A decoding algorithm for binary linear codes using Groebner bases arxiv:1810.04536v1 [cs.it] 9 Oct 2018 Harinaivo ANDRIATAHINY (1) e-mail : hariandriatahiny@gmail.com Jean Jacques Ferdinand RANDRIAMIARAMPANAHY

More information

Polynomials, Ideals, and Gröbner Bases

Polynomials, Ideals, and Gröbner Bases Polynomials, Ideals, and Gröbner Bases Notes by Bernd Sturmfels for the lecture on April 10, 2018, in the IMPRS Ringvorlesung Introduction to Nonlinear Algebra We fix a field K. Some examples of fields

More information

General error locator polynomials for binary cyclic codes with t 2 and n < 63

General error locator polynomials for binary cyclic codes with t 2 and n < 63 General error locator polynomials for binary cyclic codes with t 2 and n < 63 April 22, 2005 Teo Mora (theomora@disi.unige.it) Department of Mathematics, University of Genoa, Italy. Emmanuela Orsini (orsini@posso.dm.unipi.it)

More information

Solutions of Exam Coding Theory (2MMC30), 23 June (1.a) Consider the 4 4 matrices as words in F 16

Solutions of Exam Coding Theory (2MMC30), 23 June (1.a) Consider the 4 4 matrices as words in F 16 Solutions of Exam Coding Theory (2MMC30), 23 June 2016 (1.a) Consider the 4 4 matrices as words in F 16 2, the binary vector space of dimension 16. C is the code of all binary 4 4 matrices such that the

More information

Standard Bases for Linear Codes over Prime Fields

Standard Bases for Linear Codes over Prime Fields Standard Bases for Linear Codes over Prime Fields arxiv:1708.05490v1 cs.it] 18 Aug 2017 Jean Jacques Ferdinand RANDRIAMIARAMPANAHY 1 e-mail : randriamiferdinand@gmail.com Harinaivo ANDRIATAHINY 2 e-mail

More information

Orthogonal Arrays & Codes

Orthogonal Arrays & Codes Orthogonal Arrays & Codes Orthogonal Arrays - Redux An orthogonal array of strength t, a t-(v,k,λ)-oa, is a λv t x k array of v symbols, such that in any t columns of the array every one of the possible

More information

AN INTRODUCTION TO AFFINE TORIC VARIETIES: EMBEDDINGS AND IDEALS

AN INTRODUCTION TO AFFINE TORIC VARIETIES: EMBEDDINGS AND IDEALS AN INTRODUCTION TO AFFINE TORIC VARIETIES: EMBEDDINGS AND IDEALS JESSICA SIDMAN. Affine toric varieties: from lattice points to monomial mappings In this chapter we introduce toric varieties embedded in

More information

The cocycle lattice of binary matroids

The cocycle lattice of binary matroids Published in: Europ. J. Comb. 14 (1993), 241 250. The cocycle lattice of binary matroids László Lovász Eötvös University, Budapest, Hungary, H-1088 Princeton University, Princeton, NJ 08544 Ákos Seress*

More information

On the BMS Algorithm

On the BMS Algorithm On the BMS Algorithm Shojiro Sakata The University of Electro-Communications Department of Information and Communication Engineering Chofu-shi, Tokyo 182-8585, JAPAN Abstract I will present a sketch of

More information

Course 311: Michaelmas Term 2005 Part III: Topics in Commutative Algebra

Course 311: Michaelmas Term 2005 Part III: Topics in Commutative Algebra Course 311: Michaelmas Term 2005 Part III: Topics in Commutative Algebra D. R. Wilkins Contents 3 Topics in Commutative Algebra 2 3.1 Rings and Fields......................... 2 3.2 Ideals...............................

More information

3. Coding theory 3.1. Basic concepts

3. Coding theory 3.1. Basic concepts 3. CODING THEORY 1 3. Coding theory 3.1. Basic concepts In this chapter we will discuss briefly some aspects of error correcting codes. The main problem is that if information is sent via a noisy channel,

More information

Interesting Examples on Maximal Irreducible Goppa Codes

Interesting Examples on Maximal Irreducible Goppa Codes Interesting Examples on Maximal Irreducible Goppa Codes Marta Giorgetti Dipartimento di Fisica e Matematica, Universita dell Insubria Abstract. In this paper a full categorization of irreducible classical

More information

Computing Minimal Polynomial of Matrices over Algebraic Extension Fields

Computing Minimal Polynomial of Matrices over Algebraic Extension Fields Bull. Math. Soc. Sci. Math. Roumanie Tome 56(104) No. 2, 2013, 217 228 Computing Minimal Polynomial of Matrices over Algebraic Extension Fields by Amir Hashemi and Benyamin M.-Alizadeh Abstract In this

More information

An Algorithm to Calculate the Kernel of Certain Polynomial Ring Homomorphisms

An Algorithm to Calculate the Kernel of Certain Polynomial Ring Homomorphisms An Algorithm to Calculate the Kernel of Certain Polynomial Ring Homomorphisms Fausto Di Biase and Rüdiger Urbanke CONTENTS 1. Introduction 2. The Solution by Means of a Gröbner Basis over Kx;y 3. The Solution

More information

MATH32031: Coding Theory Part 15: Summary

MATH32031: Coding Theory Part 15: Summary MATH32031: Coding Theory Part 15: Summary 1 The initial problem The main goal of coding theory is to develop techniques which permit the detection of errors in the transmission of information and, if necessary,

More information

MCS 563 Spring 2014 Analytic Symbolic Computation Monday 14 April. Binomial Ideals

MCS 563 Spring 2014 Analytic Symbolic Computation Monday 14 April. Binomial Ideals Binomial Ideals Binomial ideals offer an interesting class of examples. Because they occur so frequently in various applications, the development methods for binomial ideals is justified. 1 Binomial Ideals

More information

Chapter 2. Error Correcting Codes. 2.1 Basic Notions

Chapter 2. Error Correcting Codes. 2.1 Basic Notions Chapter 2 Error Correcting Codes The identification number schemes we discussed in the previous chapter give us the ability to determine if an error has been made in recording or transmitting information.

More information

Total binomial decomposition (TBD) Thomas Kahle Otto-von-Guericke Universität Magdeburg

Total binomial decomposition (TBD) Thomas Kahle Otto-von-Guericke Universität Magdeburg Total binomial decomposition (TBD) Thomas Kahle Otto-von-Guericke Universität Magdeburg Setup Let k be a field. For computations we use k = Q. k[p] := k[p 1,..., p n ] the polynomial ring in n indeterminates

More information

A Saturation Algorithm for Homogeneous Binomial Ideals

A Saturation Algorithm for Homogeneous Binomial Ideals A Saturation Algorithm for Homogeneous Binomial Ideals Deepanjan Kesh and Shashank K Mehta Indian Institute of Technology, Kanpur - 208016, India, {deepkesh,skmehta}@cse.iitk.ac.in Abstract. Let k[x 1,...,

More information

CHAPTER 14. Ideals and Factor Rings

CHAPTER 14. Ideals and Factor Rings CHAPTER 14 Ideals and Factor Rings Ideals Definition (Ideal). A subring A of a ring R is called a (two-sided) ideal of R if for every r 2 R and every a 2 A, ra 2 A and ar 2 A. Note. (1) A absorbs elements

More information

SOLUTION SETS OF RECURRENCE RELATIONS

SOLUTION SETS OF RECURRENCE RELATIONS SOLUTION SETS OF RECURRENCE RELATIONS SEBASTIAN BOZLEE UNIVERSITY OF COLORADO AT BOULDER The first section of these notes describes general solutions to linear, constant-coefficient, homogeneous recurrence

More information

ALGEBRAIC GEOMETRY COURSE NOTES, LECTURE 2: HILBERT S NULLSTELLENSATZ.

ALGEBRAIC GEOMETRY COURSE NOTES, LECTURE 2: HILBERT S NULLSTELLENSATZ. ALGEBRAIC GEOMETRY COURSE NOTES, LECTURE 2: HILBERT S NULLSTELLENSATZ. ANDREW SALCH 1. Hilbert s Nullstellensatz. The last lecture left off with the claim that, if J k[x 1,..., x n ] is an ideal, then

More information

Polytopes and Algebraic Geometry. Jesús A. De Loera University of California, Davis

Polytopes and Algebraic Geometry. Jesús A. De Loera University of California, Davis Polytopes and Algebraic Geometry Jesús A. De Loera University of California, Davis Outline of the talk 1. Four classic results relating polytopes and algebraic geometry: (A) Toric Geometry (B) Viro s Theorem

More information

Lemma 1. There exists a unique minimal set of vectors 1 ; : : : ; t in S N n such t that the set of non-optimal solutions to all programs in IP A;c eq

Lemma 1. There exists a unique minimal set of vectors 1 ; : : : ; t in S N n such t that the set of non-optimal solutions to all programs in IP A;c eq GRIN: An Implementation of Grobner Bases for Integer Programming Serkan Hosten 1 and Bernd Sturmfels 2 1 School of Operations Research and Industrial Engineering Cornell University, Ithaca, New York 14853,

More information

LIFTED CODES OVER FINITE CHAIN RINGS

LIFTED CODES OVER FINITE CHAIN RINGS Math. J. Okayama Univ. 53 (2011), 39 53 LIFTED CODES OVER FINITE CHAIN RINGS Steven T. Dougherty, Hongwei Liu and Young Ho Park Abstract. In this paper, we study lifted codes over finite chain rings. We

More information

Serkan Hoşten and Rekha R. Thomas

Serkan Hoşten and Rekha R. Thomas Mathematical Research Letters 6, 83 97 (1999) THE ASSOCIATED PRIMES OF INITIAL IDEALS OF LATTICE IDEALS Serkan Hoşten and Rekha R. Thomas Abstract. This paper concerns the associated primes and primary

More information

MATH 8253 ALGEBRAIC GEOMETRY WEEK 12

MATH 8253 ALGEBRAIC GEOMETRY WEEK 12 MATH 8253 ALGEBRAIC GEOMETRY WEEK 2 CİHAN BAHRAN 3.2.. Let Y be a Noetherian scheme. Show that any Y -scheme X of finite type is Noetherian. Moreover, if Y is of finite dimension, then so is X. Write f

More information

Dynamics of finite linear cellular automata over Z N

Dynamics of finite linear cellular automata over Z N Dynamics of finite linear cellular automata over Z N F. Mendivil, D. Patterson September 9, 2009 Abstract We investigate the behaviour of linear cellular automata with state space Z N and only finitely

More information

On intersections of complete intersection ideals

On intersections of complete intersection ideals On intersections of complete intersection ideals Mircea Cimpoeaş I.M.A.R. mircea.cimpoeas@imar.ro joint work with Dumitru Stamate July 7, 2016, I.M.N.S., Levico Terme, Italy Overview 1 Introduction 2 Main

More information

Coding Theory and Applications. Solved Exercises and Problems of Cyclic Codes. Enes Pasalic University of Primorska Koper, 2013

Coding Theory and Applications. Solved Exercises and Problems of Cyclic Codes. Enes Pasalic University of Primorska Koper, 2013 Coding Theory and Applications Solved Exercises and Problems of Cyclic Codes Enes Pasalic University of Primorska Koper, 2013 Contents 1 Preface 3 2 Problems 4 2 1 Preface This is a collection of solved

More information

JORDAN AND RATIONAL CANONICAL FORMS

JORDAN AND RATIONAL CANONICAL FORMS JORDAN AND RATIONAL CANONICAL FORMS MATH 551 Throughout this note, let V be a n-dimensional vector space over a field k, and let φ: V V be a linear map Let B = {e 1,, e n } be a basis for V, and let A

More information

Circulant Hadamard matrices as HFP-codes of type C 4n C 2. arxiv: v1 [math.co] 26 Nov 2017

Circulant Hadamard matrices as HFP-codes of type C 4n C 2. arxiv: v1 [math.co] 26 Nov 2017 Circulant Hadamard matrices as HFP-codes of type C 4n C 2. arxiv:1711.09373v1 [math.co] 26 Nov 2017 J. Rifà Department of Information and Communications Engineering, Universitat Autònoma de Barcelona October

More information

Z n -GRADED POLYNOMIAL IDENTITIES OF THE FULL MATRIX ALGEBRA OF ORDER n

Z n -GRADED POLYNOMIAL IDENTITIES OF THE FULL MATRIX ALGEBRA OF ORDER n PROCEEDINGS OF THE AMERICAN MATHEMATICAL SOCIETY Volume 127, Number 12, Pages 3517 3524 S 0002-9939(99)04986-2 Article electronically published on May 13, 1999 Z n -GRADED POLYNOMIAL IDENTITIES OF THE

More information

Binomial Exercises A = 1 1 and 1

Binomial Exercises A = 1 1 and 1 Lecture I. Toric ideals. Exhibit a point configuration A whose affine semigroup NA does not consist of the intersection of the lattice ZA spanned by the columns of A with the real cone generated by A.

More information

ALGEBRA II: RINGS AND MODULES OVER LITTLE RINGS.

ALGEBRA II: RINGS AND MODULES OVER LITTLE RINGS. ALGEBRA II: RINGS AND MODULES OVER LITTLE RINGS. KEVIN MCGERTY. 1. RINGS The central characters of this course are algebraic objects known as rings. A ring is any mathematical structure where you can add

More information

7.1 Definitions and Generator Polynomials

7.1 Definitions and Generator Polynomials Chapter 7 Cyclic Codes Lecture 21, March 29, 2011 7.1 Definitions and Generator Polynomials Cyclic codes are an important class of linear codes for which the encoding and decoding can be efficiently implemented

More information

GRÖBNER BASES AND POLYNOMIAL EQUATIONS. 1. Introduction and preliminaries on Gróbner bases

GRÖBNER BASES AND POLYNOMIAL EQUATIONS. 1. Introduction and preliminaries on Gróbner bases GRÖBNER BASES AND POLYNOMIAL EQUATIONS J. K. VERMA 1. Introduction and preliminaries on Gróbner bases Let S = k[x 1, x 2,..., x n ] denote a polynomial ring over a field k where x 1, x 2,..., x n are indeterminates.

More information

SCHUR IDEALS AND HOMOMORPHISMS OF THE SEMIDEFINITE CONE

SCHUR IDEALS AND HOMOMORPHISMS OF THE SEMIDEFINITE CONE SCHUR IDEALS AND HOMOMORPHISMS OF THE SEMIDEFINITE CONE BABHRU JOSHI AND M. SEETHARAMA GOWDA Abstract. We consider the semidefinite cone K n consisting of all n n real symmetric positive semidefinite matrices.

More information

MATH 433 Applied Algebra Lecture 21: Linear codes (continued). Classification of groups.

MATH 433 Applied Algebra Lecture 21: Linear codes (continued). Classification of groups. MATH 433 Applied Algebra Lecture 21: Linear codes (continued). Classification of groups. Binary codes Let us assume that a message to be transmitted is in binary form. That is, it is a word in the alphabet

More information

Ring Theory Problems. A σ

Ring Theory Problems. A σ Ring Theory Problems 1. Given the commutative diagram α A σ B β A σ B show that α: ker σ ker σ and that β : coker σ coker σ. Here coker σ = B/σ(A). 2. Let K be a field, let V be an infinite dimensional

More information

Codewords of small weight in the (dual) code of points and k-spaces of P G(n, q)

Codewords of small weight in the (dual) code of points and k-spaces of P G(n, q) Codewords of small weight in the (dual) code of points and k-spaces of P G(n, q) M. Lavrauw L. Storme G. Van de Voorde October 4, 2007 Abstract In this paper, we study the p-ary linear code C k (n, q),

More information

Structural Grobner Basis. Bernd Sturmfels and Markus Wiegelmann TR May Department of Mathematics, UC Berkeley.

Structural Grobner Basis. Bernd Sturmfels and Markus Wiegelmann TR May Department of Mathematics, UC Berkeley. I 1947 Center St. Suite 600 Berkeley, California 94704-1198 (510) 643-9153 FAX (510) 643-7684 INTERNATIONAL COMPUTER SCIENCE INSTITUTE Structural Grobner Basis Detection Bernd Sturmfels and Markus Wiegelmann

More information

LATTICES AND BLOCK CODES

LATTICES AND BLOCK CODES U.P.B. Sci. Bull., Series A, Vol. 79, Iss. 3, 2017 ISSN 1223-7027 LATTICES AND BLOCK CODES Yulong Fu 1, Xiao Long Xin 2 Block codes have been wildly used in error-correcting area of information communication

More information

MATH 326: RINGS AND MODULES STEFAN GILLE

MATH 326: RINGS AND MODULES STEFAN GILLE MATH 326: RINGS AND MODULES STEFAN GILLE 1 2 STEFAN GILLE 1. Rings We recall first the definition of a group. 1.1. Definition. Let G be a non empty set. The set G is called a group if there is a map called

More information

GENERIC LATTICE IDEALS

GENERIC LATTICE IDEALS JOURNAL OF THE AMERICAN MATHEMATICAL SOCIETY Volume 11, Number 2, April 1998, Pages 363 373 S 0894-0347(98)00255-0 GENERIC LATTICE IDEALS IRENA PEEVA AND BERND STURMFELS I. Introduction Let S = k[x 1,...,x

More information

Lecture 12: November 6, 2017

Lecture 12: November 6, 2017 Information and Coding Theory Autumn 017 Lecturer: Madhur Tulsiani Lecture 1: November 6, 017 Recall: We were looking at codes of the form C : F k p F n p, where p is prime, k is the message length, and

More information

Hilbert function, Betti numbers. Daniel Gromada

Hilbert function, Betti numbers. Daniel Gromada Hilbert function, Betti numbers 1 Daniel Gromada References 2 David Eisenbud: Commutative Algebra with a View Toward Algebraic Geometry 19, 110 David Eisenbud: The Geometry of Syzygies 1A, 1B My own notes

More information

On non-antipodal binary completely regular codes

On non-antipodal binary completely regular codes On non-antipodal binary completely regular codes J. Borges, J. Rifà Department of Information and Communications Engineering, Universitat Autònoma de Barcelona, 08193-Bellaterra, Spain. V.A. Zinoviev Institute

More information

Commuting birth-and-death processes

Commuting birth-and-death processes Commuting birth-and-death processes Caroline Uhler Department of Statistics UC Berkeley (joint work with Steven N. Evans and Bernd Sturmfels) MSRI Workshop on Algebraic Statistics December 18, 2008 Birth-and-death

More information

Introduction to finite fields

Introduction to finite fields Chapter 7 Introduction to finite fields This chapter provides an introduction to several kinds of abstract algebraic structures, particularly groups, fields, and polynomials. Our primary interest is in

More information

Algebraic Varieties. Notes by Mateusz Micha lek for the lecture on April 17, 2018, in the IMPRS Ringvorlesung Introduction to Nonlinear Algebra

Algebraic Varieties. Notes by Mateusz Micha lek for the lecture on April 17, 2018, in the IMPRS Ringvorlesung Introduction to Nonlinear Algebra Algebraic Varieties Notes by Mateusz Micha lek for the lecture on April 17, 2018, in the IMPRS Ringvorlesung Introduction to Nonlinear Algebra Algebraic varieties represent solutions of a system of polynomial

More information

Outline. MSRI-UP 2009 Coding Theory Seminar, Week 2. The definition. Link to polynomials

Outline. MSRI-UP 2009 Coding Theory Seminar, Week 2. The definition. Link to polynomials Outline MSRI-UP 2009 Coding Theory Seminar, Week 2 John B. Little Department of Mathematics and Computer Science College of the Holy Cross Cyclic Codes Polynomial Algebra More on cyclic codes Finite fields

More information

Skew Cyclic Codes Of Arbitrary Length

Skew Cyclic Codes Of Arbitrary Length Skew Cyclic Codes Of Arbitrary Length Irfan Siap Department of Mathematics, Adıyaman University, Adıyaman, TURKEY, isiap@adiyaman.edu.tr Taher Abualrub Department of Mathematics and Statistics, American

More information

MINIMAL CODEWORDS IN LINEAR CODES. Yuri Borissov, Nickolai Manev

MINIMAL CODEWORDS IN LINEAR CODES. Yuri Borissov, Nickolai Manev Serdica Math. J. 30 (2004, 303 324 MINIMAL CODEWORDS IN LINEAR CODES Yuri Borissov, Nickolai Manev Communicated by V. Brînzănescu Abstract. Cyclic binary codes C of block length n = 2 m 1 and generator

More information

Lecture 12. Block Diagram

Lecture 12. Block Diagram Lecture 12 Goals Be able to encode using a linear block code Be able to decode a linear block code received over a binary symmetric channel or an additive white Gaussian channel XII-1 Block Diagram Data

More information

HILBERT BASIS OF THE LIPMAN SEMIGROUP

HILBERT BASIS OF THE LIPMAN SEMIGROUP Available at: http://publications.ictp.it IC/2010/061 United Nations Educational, Scientific and Cultural Organization and International Atomic Energy Agency THE ABDUS SALAM INTERNATIONAL CENTRE FOR THEORETICAL

More information

Know the meaning of the basic concepts: ring, field, characteristic of a ring, the ring of polynomials R[x].

Know the meaning of the basic concepts: ring, field, characteristic of a ring, the ring of polynomials R[x]. The second exam will be on Friday, October 28, 2. It will cover Sections.7,.8, 3., 3.2, 3.4 (except 3.4.), 4. and 4.2 plus the handout on calculation of high powers of an integer modulo n via successive

More information

CYCLIC SIEVING FOR CYCLIC CODES

CYCLIC SIEVING FOR CYCLIC CODES CYCLIC SIEVING FOR CYCLIC CODES ALEX MASON, VICTOR REINER, SHRUTHI SRIDHAR Abstract. These are notes on a preliminary follow-up to a question of Jim Propp, about cyclic sieving of cyclic codes. We show

More information

Chapter 6 Reed-Solomon Codes. 6.1 Finite Field Algebra 6.2 Reed-Solomon Codes 6.3 Syndrome Based Decoding 6.4 Curve-Fitting Based Decoding

Chapter 6 Reed-Solomon Codes. 6.1 Finite Field Algebra 6.2 Reed-Solomon Codes 6.3 Syndrome Based Decoding 6.4 Curve-Fitting Based Decoding Chapter 6 Reed-Solomon Codes 6. Finite Field Algebra 6. Reed-Solomon Codes 6.3 Syndrome Based Decoding 6.4 Curve-Fitting Based Decoding 6. Finite Field Algebra Nonbinary codes: message and codeword symbols

More information

PRIMARY DECOMPOSITION FOR THE INTERSECTION AXIOM

PRIMARY DECOMPOSITION FOR THE INTERSECTION AXIOM PRIMARY DECOMPOSITION FOR THE INTERSECTION AXIOM ALEX FINK 1. Introduction and background Consider the discrete conditional independence model M given by {X 1 X 2 X 3, X 1 X 3 X 2 }. The intersection axiom

More information

Finite Fields. Sophie Huczynska. Semester 2, Academic Year

Finite Fields. Sophie Huczynska. Semester 2, Academic Year Finite Fields Sophie Huczynska Semester 2, Academic Year 2005-06 2 Chapter 1. Introduction Finite fields is a branch of mathematics which has come to the fore in the last 50 years due to its numerous applications,

More information

The universal Gröbner basis of a binomial edge ideal

The universal Gröbner basis of a binomial edge ideal The universal Gröbner basis of a binomial edge ideal Mourtadha Badiane Isaac Burke Emil Sköldberg National University of Ireland, Galway Galway, Ireland {m.badiane1,i.burke1,emil.skoldberg}@nuigalway.ie

More information

Simplicial complexes, Demi-matroids, Flag of linear codes and pair of matroids

Simplicial complexes, Demi-matroids, Flag of linear codes and pair of matroids Faculty of Science and Technology Department of Mathematics and Statistics Simplicial complexes, Demi-matroids, Flag of linear codes and pair of matroids Ali Zubair MAT-3900 Master s thesis in Mathematics

More information

AN INTRODUCTION TO TORIC SURFACES

AN INTRODUCTION TO TORIC SURFACES AN INTRODUCTION TO TORIC SURFACES JESSICA SIDMAN 1. An introduction to affine varieties To motivate what is to come we revisit a familiar example from high school algebra from a point of view that allows

More information

The generic Gröbner walk

The generic Gröbner walk The generic Gröbner walk K. Fukuda, A. N. Jensen, N. Lauritzen, R. Thomas May 23, 2006 arxiv:math.ac/0501345 v3 13 Oct 2005 Abstract The Gröbner walk is an algorithm for conversion between Gröbner bases

More information

Lecture 4 February 5

Lecture 4 February 5 Math 239: Discrete Mathematics for the Life Sciences Spring 2008 Lecture 4 February 5 Lecturer: Lior Pachter Scribe/ Editor: Michaeel Kazi/ Cynthia Vinzant 4.1 Introduction to Gröbner Bases In this lecture

More information

Linear Programming Decoding of Binary Linear Codes for Symbol-Pair Read Channels

Linear Programming Decoding of Binary Linear Codes for Symbol-Pair Read Channels 1 Linear Programming Decoding of Binary Linear Codes for Symbol-Pair Read Channels Shunsuke Horii, Toshiyasu Matsushima, and Shigeichi Hirasawa arxiv:1508.01640v2 [cs.it] 29 Sep 2015 Abstract In this paper,

More information

Nonlinear Discrete Optimization

Nonlinear Discrete Optimization Nonlinear Discrete Optimization Technion Israel Institute of Technology http://ie.technion.ac.il/~onn Billerafest 2008 - conference in honor of Lou Billera's 65th birthday (Update on Lecture Series given

More information

Math 210B. Artin Rees and completions

Math 210B. Artin Rees and completions Math 210B. Artin Rees and completions 1. Definitions and an example Let A be a ring, I an ideal, and M an A-module. In class we defined the I-adic completion of M to be M = lim M/I n M. We will soon show

More information

QUADRATIC RESIDUE CODES OVER Z 9

QUADRATIC RESIDUE CODES OVER Z 9 J. Korean Math. Soc. 46 (009), No. 1, pp. 13 30 QUADRATIC RESIDUE CODES OVER Z 9 Bijan Taeri Abstract. A subset of n tuples of elements of Z 9 is said to be a code over Z 9 if it is a Z 9 -module. In this

More information

LEVEL MATRICES G. SEELINGER, P. SISSOKHO, L. SPENCE, AND C. VANDEN EYNDEN

LEVEL MATRICES G. SEELINGER, P. SISSOKHO, L. SPENCE, AND C. VANDEN EYNDEN LEVEL MATRICES G. SEELINGER, P. SISSOKHO, L. SPENCE, AND C. VANDEN EYNDEN Abstract. Let n > 1 and k > 0 be fixed integers. A matrix is said to be level if all its column sums are equal. A level matrix

More information

Lecture Introduction. 2 Linear codes. CS CTT Current Topics in Theoretical CS Oct 4, 2012

Lecture Introduction. 2 Linear codes. CS CTT Current Topics in Theoretical CS Oct 4, 2012 CS 59000 CTT Current Topics in Theoretical CS Oct 4, 01 Lecturer: Elena Grigorescu Lecture 14 Scribe: Selvakumaran Vadivelmurugan 1 Introduction We introduced error-correcting codes and linear codes in

More information

arxiv:math/ v1 [math.ac] 11 Nov 2005

arxiv:math/ v1 [math.ac] 11 Nov 2005 A note on Rees algebras and the MFMC property arxiv:math/0511307v1 [math.ac] 11 Nov 2005 Isidoro Gitler, Carlos E. Valencia and Rafael H. Villarreal 1 Departamento de Matemáticas Centro de Investigación

More information

: Error Correcting Codes. October 2017 Lecture 1

: Error Correcting Codes. October 2017 Lecture 1 03683072: Error Correcting Codes. October 2017 Lecture 1 First Definitions and Basic Codes Amnon Ta-Shma and Dean Doron 1 Error Correcting Codes Basics Definition 1. An (n, K, d) q code is a subset of

More information

Secret-sharing with a class of ternary codes

Secret-sharing with a class of ternary codes Theoretical Computer Science 246 (2000) 285 298 www.elsevier.com/locate/tcs Note Secret-sharing with a class of ternary codes Cunsheng Ding a, David R Kohel b, San Ling c; a Department of Computer Science,

More information

Proof: Let the check matrix be

Proof: Let the check matrix be Review/Outline Recall: Looking for good codes High info rate vs. high min distance Want simple description, too Linear, even cyclic, plausible Gilbert-Varshamov bound for linear codes Check matrix criterion

More information

A finite universal SAGBI basis for the kernel of a derivation. Osaka Journal of Mathematics. 41(4) P.759-P.792

A finite universal SAGBI basis for the kernel of a derivation. Osaka Journal of Mathematics. 41(4) P.759-P.792 Title Author(s) A finite universal SAGBI basis for the kernel of a derivation Kuroda, Shigeru Citation Osaka Journal of Mathematics. 4(4) P.759-P.792 Issue Date 2004-2 Text Version publisher URL https://doi.org/0.890/838

More information

MATH 205B NOTES 2010 COMMUTATIVE ALGEBRA 53

MATH 205B NOTES 2010 COMMUTATIVE ALGEBRA 53 MATH 205B NOTES 2010 COMMUTATIVE ALGEBRA 53 10. Completion The real numbers are the completion of the rational numbers with respect to the usual absolute value norm. This means that any Cauchy sequence

More information

Lecture 1. (i,j) N 2 kx i y j, and this makes k[x, y]

Lecture 1. (i,j) N 2 kx i y j, and this makes k[x, y] Lecture 1 1. Polynomial Rings, Gröbner Bases Definition 1.1. Let R be a ring, G an abelian semigroup, and R = i G R i a direct sum decomposition of abelian groups. R is graded (G-graded) if R i R j R i+j

More information

Open Questions in Coding Theory

Open Questions in Coding Theory Open Questions in Coding Theory Steven T. Dougherty July 4, 2013 Open Questions The following questions were posed by: S.T. Dougherty J.L. Kim P. Solé J. Wood Hilbert Style Problems Hilbert Style Problems

More information

THIS paper is aimed at designing efficient decoding algorithms

THIS paper is aimed at designing efficient decoding algorithms IEEE TRANSACTIONS ON INFORMATION THEORY, VOL. 45, NO. 7, NOVEMBER 1999 2333 Sort-and-Match Algorithm for Soft-Decision Decoding Ilya Dumer, Member, IEEE Abstract Let a q-ary linear (n; k)-code C be used

More information

on Newton polytopes, tropisms, and Puiseux series to solve polynomial systems

on Newton polytopes, tropisms, and Puiseux series to solve polynomial systems on Newton polytopes, tropisms, and Puiseux series to solve polynomial systems Jan Verschelde joint work with Danko Adrovic University of Illinois at Chicago Department of Mathematics, Statistics, and Computer

More information

FREE RESOLUTION OF POWERS OF MONOMIAL IDEALS AND GOLOD RINGS

FREE RESOLUTION OF POWERS OF MONOMIAL IDEALS AND GOLOD RINGS FREE RESOLUTION OF POWERS OF MONOMIAL IDEALS AND GOLOD RINGS N. ALTAFI, N. NEMATI, S. A. SEYED FAKHARI, AND S. YASSEMI Abstract. Let S = K[x 1,..., x n ] be the polynomial ring over a field K. In this

More information

Finite Fields. Sophie Huczynska (with changes by Max Neunhöffer) Semester 2, Academic Year 2012/13

Finite Fields. Sophie Huczynska (with changes by Max Neunhöffer) Semester 2, Academic Year 2012/13 Finite Fields Sophie Huczynska (with changes by Max Neunhöffer) Semester 2, Academic Year 2012/13 Contents 1 Introduction 3 1 Group theory: a brief summary............................ 3 2 Rings and fields....................................

More information

The Berlekamp-Massey Algorithm revisited

The Berlekamp-Massey Algorithm revisited The Berlekamp-Massey Algorithm revisited Nadia Ben Atti ( ), Gema M Diaz Toca ( ) Henri Lombardi ( ) Abstract We propose a slight modification of the Berlekamp-Massey Algorithm for obtaining the minimal

More information

COMMUNICATIONS IN ALGEBRA, 15(3), (1987) A NOTE ON PRIME IDEALS WHICH TEST INJECTIVITY. John A. Beachy and William D.

COMMUNICATIONS IN ALGEBRA, 15(3), (1987) A NOTE ON PRIME IDEALS WHICH TEST INJECTIVITY. John A. Beachy and William D. COMMUNICATIONS IN ALGEBRA, 15(3), 471 478 (1987) A NOTE ON PRIME IDEALS WHICH TEST INJECTIVITY John A. Beachy and William D. Weakley Department of Mathematical Sciences Northern Illinois University DeKalb,

More information

T. Hibi Binomial ideals arising from combinatorics

T. Hibi Binomial ideals arising from combinatorics T. Hibi Binomial ideals arising from combinatorics lecture notes written by Filip Rupniewski (email: frupniewski@impan.pl) Binomial Ideals conference 3-9 September 207, Łukęcin, Poland Lecture Let S =

More information

Course 2316 Sample Paper 1

Course 2316 Sample Paper 1 Course 2316 Sample Paper 1 Timothy Murphy April 19, 2015 Attempt 5 questions. All carry the same mark. 1. State and prove the Fundamental Theorem of Arithmetic (for N). Prove that there are an infinity

More information

Plotkin s Bound in Codes Equipped with the Euclidean Weight Function

Plotkin s Bound in Codes Equipped with the Euclidean Weight Function Tamsui Oxford Journal of Mathematical Sciences 5() (009) 07-4 Aletheia University Plotkin s Bound in Codes Equipped with the Euclidean Weight Function Sapna Jain Department of Mathematics, University of

More information

Summer Project. August 10, 2001

Summer Project. August 10, 2001 Summer Project Bhavana Nancherla David Drescher August 10, 2001 Over the summer we embarked on a brief introduction to various concepts in algebraic geometry. We used the text Ideals, Varieties, and Algorithms,

More information

Maximum exponent of boolean circulant matrices with constant number of nonzero entries in its generating vector

Maximum exponent of boolean circulant matrices with constant number of nonzero entries in its generating vector Maximum exponent of boolean circulant matrices with constant number of nonzero entries in its generating vector MI Bueno, Department of Mathematics and The College of Creative Studies University of California,

More information

arxiv:math/ v1 [math.ac] 11 Jul 2006

arxiv:math/ v1 [math.ac] 11 Jul 2006 arxiv:math/0607249v1 [math.ac] 11 Jul 2006 MINIMAL SYSTEMS OF BINOMIAL GENERATORS AND THE INDISPENSABLE COMPLEX OF A TORIC IDEAL HARA CHARALAMBOUS, ANARGYROS KATSABEKIS, AND APOSTOLOS THOMA Abstract. Let

More information

= 1 2x. x 2 a ) 0 (mod p n ), (x 2 + 2a + a2. x a ) 2

= 1 2x. x 2 a ) 0 (mod p n ), (x 2 + 2a + a2. x a ) 2 8. p-adic numbers 8.1. Motivation: Solving x 2 a (mod p n ). Take an odd prime p, and ( an) integer a coprime to p. Then, as we know, x 2 a (mod p) has a solution x Z iff = 1. In this case we can suppose

More information

General error locator polynomials for nth-root codes

General error locator polynomials for nth-root codes General error locator polynomials for nth-root codes Marta Giorgetti 1 and Massimiliano Sala 2 1 Department of Mathematics, University of Milano, Italy 2 Boole Centre for Research in Informatics, UCC Cork,

More information