Polynomial ring


In mathematics, especially in the field of algebra, a polynomial ring or polynomial algebra is a ring (which is also a commutative algebra) formed from the set of polynomials in one or more indeterminates (traditionally also called variables) with coefficients in another ring, often a field.


Polynomial rings occur in many parts of mathematics, and the study of their properties was among the main motivations for the development of commutative algebra and ring theory. Polynomial rings and their ideals are fundamental in algebraic geometry. Many classes of rings, such as unique factorization domains, regular rings, group rings, rings of formal power series, Ore polynomials, graded rings, are generalizations of polynomial rings.


A closely related notion is that of the ring of polynomial functions on a vector space, and, more generally, ring of regular functions on an algebraic variety.




Contents





  • 1 The polynomial ring K[X]

    • 1.1 Definition


    • 1.2 Degree of a polynomial


    • 1.3 Properties of K[X]

      • 1.3.1 Factorization in K[X]


      • 1.3.2 Quotient ring of K[X]



    • 1.4 Modules



  • 2 Polynomial evaluation


  • 3 The polynomial ring in several variables

    • 3.1 Polynomials


    • 3.2 The polynomial ring


    • 3.3 Hilbert's Nullstellensatz



  • 4 Properties of the ring extension RR[X]

    • 4.1 Summary of the results



  • 5 Generalizations

    • 5.1 Infinitely many variables


    • 5.2 Generalized exponents


    • 5.3 Power series


    • 5.4 Noncommutative polynomial rings


    • 5.5 Differential and skew-polynomial rings



  • 6 See also


  • 7 References




The polynomial ring K[X]



Definition


The polynomial ring, K[X], in X over a field K is defined[1] as the set of expressions, called polynomials in X, of the form


p=p0+p1X+p2X2+⋯+pm−1Xm−1+pmXm,displaystyle p=p_0+p_1X+p_2X^2+cdots +p_m-1X^m-1+p_mX^m,p=p_0+p_1X+p_2X^2+cdots +p_m-1X^m-1+p_mX^m,

where p0, p1, ..., pm, the coefficients of p, are elements of K, and X, X2, are symbols, which are considered as "powers of X", and, by convention, follow the usual rules of exponentiation: X0 = 1, X1 = X, and XkXl=Xk+ldisplaystyle X^k,X^l=X^k+ldisplaystyle X^k,X^l=X^k+l for any nonnegative integers k and l. The symbol X is called an indeterminate[2] or variable.[3]


Two polynomials are defined to be equal when the corresponding coefficient of each Xk is equal.


This terminology is suggested by real or complex polynomial functions. However, in general, X and its powers, Xk, are treated as formal symbols, not as elements of the field K or functions over it. One can think of the ring K[X] as arising from K by adding one new element X that is external to K and requiring that X commute with all elements of K.


The polynomial ring in X over K is equipped with an addition, a multiplication and a scalar multiplication that make it a commutative algebra. These operations are defined according to the ordinary rules for manipulating algebraic expressions. Specifically, if


p=p0+p1X+p2X2+⋯+pmXm,displaystyle p=p_0+p_1X+p_2X^2+cdots +p_mX^m,p=p_0+p_1X+p_2X^2+cdots +p_mX^m,

and


q=q0+q1X+q2X2+⋯+qnXn,displaystyle q=q_0+q_1X+q_2X^2+cdots +q_nX^n,q=q_0+q_1X+q_2X^2+cdots +q_nX^n,

then


p+q=r0+r1X+r2X2+⋯+rkXk,displaystyle p+q=r_0+r_1X+r_2X^2+cdots +r_kX^k,p+q=r_0+r_1X+r_2X^2+cdots +r_kX^k,

and


pq=s0+s1X+s2X2+⋯+slXl,displaystyle pq=s_0+s_1X+s_2X^2+cdots +s_lX^l,pq=s_0+s_1X+s_2X^2+cdots +s_lX^l,

where k = max(m, n), l = m + n,


ri=pi+qidisplaystyle r_i=p_i+q_ir_i=p_i+q_i

and


si=p0qi+p1qi−1+⋯+piq0.displaystyle s_i=p_0q_i+p_1q_i-1+cdots +p_iq_0.s_i=p_0q_i+p_1q_i-1+cdots +p_iq_0.

If necessary, the polynomials p and q are extended by adding "dummy terms" with zero coefficients, so that the expressions for ri and si are always defined. Specifically, if m < n, then pi = 0 for m < in.


The scalar multiplication is the special case of the multiplication where p = p0 is reduced to its term which is independent of X, that is


p0(q0+q1X+…qnXn)=p0q0+(p0q1)X+⋯+(p0qn)Xndisplaystyle p_0(q_0+q_1X+dots q_nX^n)=p_0q_0+(p_0q_1)X+cdots +(p_0q_n)X^np_0(q_0+q_1X+dots q_nX^n)=p_0q_0+(p_0q_1)X+cdots +(p_0q_n)X^n

It is easy to verify that these three operations satisfy the axioms of a commutative algebra. Therefore, polynomial rings are also called polynomial algebras.


Another equivalent definition is often preferred, although less intuitive, because it is easier to make it completely rigorous, which consists in defining a polynomial as an infinite sequence of elements of K, (p0, p1, p2, ... ) having the property that only a finite number of the elements are nonzero, or equivalently, a sequence for which there is some m so that pn = 0 for n > m. In this case, the expression


p0+p1X+p2X2+⋯+pmXmdisplaystyle p_0+p_1X+p_2X^2+cdots +p_mX^mp_0+p_1X+p_2X^2+cdots +p_mX^m

is considered an alternate notation for the sequence (p0, p1, p2, ..., pm, 0, 0, ...).


More generally, the field K can be replaced by any commutative ring R when taking the same construction as above, giving rise to the polynomial ring over R, which is denoted R[X].



Degree of a polynomial


The degree of a polynomial p, written deg(p) is the largest k such that the coefficient of Xk is not zero.[4] In this case the coefficient pk is called the leading coefficient.[5] In the special case of zero polynomial, all of whose coefficients are zero, the degree has been variously left undefined,[6] defined to be −1,[7] or defined to be a special symbol −∞.[8]


If K is a field, or more generally an integral domain, then from the definition of multiplication,[9]


deg⁡(pq)=deg⁡(p)+deg⁡(q).displaystyle operatorname deg (pq)=operatorname deg (p)+operatorname deg (q).operatorname deg (pq)=operatorname deg (p)+operatorname deg (q).

It follows immediately that if K is an integral domain then so is K[X].[10]



Properties of K[X]



Factorization in K[X]


The next property of the polynomial ring is much deeper. Already Euclid noted that every positive integer can be uniquely factored into a product of primes — this statement is now called the fundamental theorem of arithmetic. The proof is based on Euclid's algorithm for finding the greatest common divisor of natural numbers. At each step of this algorithm, a pair (a, b), a > b, of natural numbers is replaced by a new pair (b, r), where r is the remainder from the division of a by b, and the new numbers are smaller. Gauss remarked that the procedure of division with the remainder can also be defined for polynomials: given two polynomials p and q, where q ≠ 0, one can write


p=uq+r,displaystyle p=uq+r,displaystyle p=uq+r,

where the quotient u and the remainder r are polynomials, the degree of r is less than the degree of q, and a decomposition with these properties is unique. The quotient and the remainder are found using the polynomial long division. The degree of the polynomial now plays a role similar to the absolute value of an integer: it is strictly less in the remainder r than it is in q, and when repeating this step such decrease cannot go on indefinitely. Therefore, eventually some division will be exact, at which point the last non-zero remainder is the greatest common divisor of the initial two polynomials. Using the existence of greatest common divisors, Gauss was able to simultaneously rigorously prove the fundamental theorem of arithmetic for integers and its generalization to polynomials. In fact there exist other commutative rings than Z and K[X] that similarly admit an analogue of the Euclidean algorithm; all such rings are called Euclidean rings. Rings for which there exists unique (in an appropriate sense) factorization of nonzero elements into irreducible factors are called unique factorization domains or factorial rings; the given construction shows that all Euclidean rings, and in particular Z and K[X], are unique factorization domains.


Although Euclidean algorithm allows proving the unique factorization property, it does not provide any algorithm for computing the factorization. For integers, there are factorization algorithms. However, even with the fastest computers, there are unable to factorize large integers with few large prime factors. This is the basis idea of the RSA cryptosystem, that is widely used for secure internet communications. For polynomials over the integers, over the rational numbers, or over a finite field there are efficient algorithms that are implemented in computer algebra systems (see Factorization of polynomials). On the other hand, there is an example of a field F such that there exist algorithms for the operations of F, but there cannot exist any algorithm for deciding whether a polynomial of the form Xp−adisplaystyle X^p-adisplaystyle X^p-a is irreducible or is a product of polynomials of lower degree.[11]


Another corollary of the polynomial division with the remainder is the fact that every proper ideal I of K[X] is principal, i.e. I consists of the multiples of a single polynomial f. Thus the polynomial ring K[X] is a principal ideal domain, and for the same reason every Euclidean domain is a principal ideal domain. Also every principal ideal domain is a unique-factorization domain. These deductions make essential use of the fact that the polynomial coefficients lie in a field, namely in the polynomial division step, which requires the leading coefficient of q, which is only known to be non-zero, to have an inverse. If R is an integral domain that is not a field then R[X] is neither a Euclidean domain nor a principal ideal domain; however it could still be a unique factorization domain (and will be so if and only if R itself is a unique factorization domain, for instance if it is Z or another polynomial ring).



Quotient ring of K[X]


The ring K[X] of polynomials over K is obtained from K by adjoining one element, X. It turns out that any commutative ring L containing K and generated as a ring by a single element in addition to K can be described using K[X]. In particular, this applies to finite field extensions of K.


Let us consider an element θ in a commutative ring L that contains K. There is a unique ring homomorphism φ from K[X] into L that maps X to θ and does not affect the elements of K itself (it is the identity map on K). This homomorphism is unique since it must maps each power of X to the same power of θ and any linear combination of powers of X with coefficients in K to the same linear combination of powers of X. It consists thus of "replacing X with θ" in every polynomial.


φ(amXm+am−1Xm−1+⋯+a1X+a0)=amθm+am−1θm−1+⋯+a1θ+a0.displaystyle varphi (a_mX^m+a_m-1X^m-1+cdots +a_1X+a_0)=a_mtheta ^m+a_m-1theta ^m-1+cdots +a_1theta +a_0.varphi (a_mX^m+a_m-1X^m-1+cdots +a_1X+a_0)=a_mtheta ^m+a_m-1theta ^m-1+cdots +a_1theta +a_0.

If L is generated as a ring by adding θ to K, any element of L appears as the right hand side of the last expression for suitable m and elements a0, ..., am of K. Therefore, φ is surjective and L is a homomorphic image of K[X]. More formally, let Ker φ be the kernel of φ. It is an ideal of K[X] and by the first isomorphism theorem for rings, L is isomorphic to the quotient of the polynomial ring K[X] by the ideal Ker φ. Since the polynomial ring is a principal ideal domain, this ideal is principal: there exists a polynomial pK[X] such that


L≃K[X]/(p),displaystyle Lsimeq K[X]/(p),displaystyle Lsimeq K[X]/(p),

where (p)displaystyle (p)(p) denotes the ideal generated by p.displaystyle p.p.


A particularly important application is to the case when the larger ring L is a field. Then the polynomial p must be irreducible. Conversely, the primitive element theorem states that any finite separable field extension L/K can be generated by a single element θL and the preceding theory then gives a concrete description of the field L as the quotient of the polynomial ring K[X] by a principal ideal generated by an irreducible polynomial p. As an illustration, the field C of complex numbers is an extension of the field R of real numbers generated by a single element i such that i2 + 1 = 0. Accordingly, the polynomial X2 + 1 is irreducible over R and


C≃R[X]/(X2+1).displaystyle mathbb C simeq mathbb R [X]/(X^2+1).mathbb C simeq mathbb R [X]/(X^2+1).

More generally, given a (not necessarily commutative) ring A containing K and an element a of A that commutes with all elements of K, there is a unique ring homomorphism from the polynomial ring K[X] to A that maps X to a:


ϕ:K[X]→A,ϕ(X)=a.displaystyle phi :K[X]to A,quad phi (X)=a.phi :K[X]to A,quad phi (X)=a.

This homomorphism is given by the same formula as before, but it is not surjective in general. The existence and uniqueness of such a homomorphism φ expresses a certain universal property of the ring of polynomials in one variable and explains the ubiquity of polynomial rings in various questions and constructions of ring theory and commutative algebra.



Modules


The structure theorem for finitely generated modules over a principal ideal domain applies to
K[X]. This means that every finitely generated module over K[X] may be decomposed into a direct sum of a free module and finitely many modules of the form K[X]/⟨Pk⟩displaystyle K[X]/langle P^krangle K[X]/langle P^krangle , where P is an irreducible polynomial over K and k a positive integer.



Polynomial evaluation


Let K be a field or, more generally, a commutative ring, and R a ring containing K. For any polynomial P in K[X] and any element a in R, the substitution of X by a in P defines an element of R, which is denoted P(a). This element is obtained by, after the substitution, carrying on, in R, the operations indicated by the expression of the polynomial. This computation is called the evaluation of P at a. For example, if we have


P=X2−1,displaystyle P=X^2-1,P=X^2-1,

we have


P(3)=32−1=8,displaystyle P(3)=3^2-1=8,P(3)=3^2-1=8,

P(X2+1)=(X2+1)2−1=X4+2X2displaystyle P(X^2+1)=(X^2+1)^2-1=X^4+2X^2P(X^2+1)=(X^2+1)^2-1=X^4+2X^2

(in the first example R = K, and in the second one R = K[X]). Substituting X by itself results in


P=P(X),displaystyle P=P(X),P=P(X),

explaining why the sentences "Let P be a polynomial" and "Let P(X) be a polynomial" are equivalent.


For every a in R, the map P↦P(a)displaystyle Pmapsto P(a)Pmapsto P(a) defines a ring homomorphism from K[X] into R.


The polynomial function defined by a polynomial P is the function from K into K that is defined by x↦P(x).displaystyle xmapsto P(x).xmapsto P(x). If K is an infinite field, two different polynomials define different polynomial functions, but this property is false for finite fields. For example, if K is a field with q elements, then the polynomials 0 and Xq-X both define the zero function.



The polynomial ring in several variables




Polynomials


A polynomial in n variables X1, …, Xn with coefficients in a field K is defined analogously to a polynomial in one variable, but the notation is more cumbersome. For any multi-index α = (α1, …, αn), where each αi is a non-negative integer, let


Xα=∏i=1nXiαi=X1α1…Xnαn.displaystyle X^alpha =prod _i=1^nX_i^alpha _i=X_1^alpha _1ldots X_n^alpha _n.X^alpha =prod _i=1^nX_i^alpha _i=X_1^alpha _1ldots X_n^alpha _n.

The product Xα is called the monomial of multidegree α. A polynomial is a finite linear combination of monomials with coefficients in K


p=∑αpαXα,displaystyle p=sum _alpha p_alpha X^alpha ,p=sum _alpha p_alpha X^alpha ,

where
pα=pα1,…,αn∈K,displaystyle p_alpha =p_alpha _1,ldots ,alpha _nin K,p_alpha =p_alpha _1,ldots ,alpha _nin K,
and only finitely many coefficients pα are different from 0. The degree of a monomial Xα, frequently denoted |α|, is defined as


|α|=∑i=1nαi, alpha |alpha |=sum _i=1^nalpha _i,

and the degree of a polynomial p is the largest degree of a monomial occurring with non-zero coefficient in the expansion of p.



The polynomial ring



Polynomials in n variables with coefficients in K form a commutative ring denoted
K[X1, ..., Xn], or sometimes K[X], where X is a symbol representing the full set of variables, X = (X1, ..., Xn), and called the polynomial ring in n variables. The polynomial ring in n variables can be obtained by repeated application of K[X] (the order by which is irrelevant). For example, K[X1, X2] is isomorphic to K[X1][X2].


Polynomials in several variables play fundamental role in algebraic geometry. Many results in commutative and homological algebra originated in the study of ideals and modules over polynomial rings.


Polynomial rings may also be referred to as free commutative algebras, since they are the free objects in the category of commutative algebras. Similarly, a polynomial ring with coefficients in the integers is the free commutative ring over its set of variables.



Hilbert's Nullstellensatz



A group of fundamental results concerning the relation between ideals of the polynomial ring K[X1,…, Xn] and algebraic subsets of Kn originating with David Hilbert is known under the name Nullstellensatz (literally: "zero-locus theorem").


  • (Weak form, algebraically closed field of coefficients). Let K be an algebraically closed field. Then every maximal ideal m of K[X1,…, Xn] has the form
m=(X1−a1,…,Xn−an),a=(a1,…,an)∈Kn.displaystyle m=(X_1-a_1,ldots ,X_n-a_n),quad a=(a_1,ldots ,a_n)in K^n.m=(X_1-a_1,ldots ,X_n-a_n),quad a=(a_1,ldots ,a_n)in K^n.
  • (Weak form, any field of coefficients). Let k be a field, K be an algebraically closed field extension of k, and I be an ideal in the polynomial ring k[X1,…, Xn]. Then I contains 1 if and only if the polynomials in I do not have any common zero in Kn.

  • (Strong form). Let k be a field, K be an algebraically closed field extension of k, I be an ideal in the polynomial ring k[X1,…, Xn],and V(I) be the algebraic subset of Kn defined by I. Suppose that f is a polynomial which vanishes at all points of V(I). Then some power of f belongs to the ideal I:

fm∈I, for some m∈N.displaystyle f^min I,text for some min mathbb N .,f^min I,text for some min mathbb N .,
Using the notion of the radical of an ideal, the conclusion says that f belongs to the radical of I. As a corollary of this form of Nullstellensatz, there is a bijective correspondence between the radical ideals of K[X1,…, Xn] for an algebraically closed field K and the algebraic subsets of the n-dimensional affine space Kn. It arises from the map
I↦V(I),I⊂K[X1,…,Xn],V(I)⊂Kn.displaystyle Imapsto V(I),quad Isubset K[X_1,ldots ,X_n],quad V(I)subset K^n.Imapsto V(I),quad Isubset K[X_1,ldots ,X_n],quad V(I)subset K^n.
The prime ideals of the polynomial ring correspond to irreducible subvarieties of Kn.


Properties of the ring extension RR[X]


One of the basic techniques in commutative algebra is to relate properties of a ring with properties of its subrings. The notation RS indicates that a ring R is a subring of a ring S. In this case S is called an overring of R and one speaks of a ring extension. This works particularly well for polynomial rings and allows one to establish many important properties of the ring of polynomials in several variables over a field, K[X1,…, Xn], by induction in n.



Summary of the results


In the following properties, R is a commutative ring and S = R[X1,…, Xn] is the ring of polynomials in n variables over R. The ring extension RS can be built from R in n steps, by successively adjoining X1,…, Xn. Thus to establish each of the properties below, it is sufficient to consider the case n = 1.


  • If R is an integral domain then the same holds for S.

  • If R is a unique factorization domain then the same holds for S. The proof is based on the Gauss lemma.


  • Hilbert's basis theorem: If R is a Noetherian ring, then the same holds for S.

  • Suppose that R is a Noetherian ring of finite global dimension. Then

gldim⁡R[X1,…,Xn]=gldim⁡R+n.displaystyle operatorname gl ,dim R[X_1,ldots ,X_n]=operatorname gl ,dim R+n.operatorname gl ,dim R[X_1,ldots ,X_n]=operatorname gl ,dim R+n.
An analogous result holds for Krull dimension.


Generalizations


Polynomial rings can be generalized in a great many ways, including polynomial rings with generalized exponents, power series rings, noncommutative polynomial rings, and skew-polynomial rings.



Infinitely many variables


One slight generalization of polynomial rings is to allow for infinitely many indeterminates. Each monomial still involves only a finite number of indeterminates (so that its degree remains finite), and each polynomial is a still a (finite) linear combination of monomials. Thus, any individual polynomial involves only finitely many indeterminates, and any finite computation involving polynomials remains inside some subring of polynomials in finitely many indeterminates.


In the case of infinitely many indeterminates, one can consider a ring strictly larger than the polynomial ring but smaller than the power series ring, by taking the subring of the latter formed by power series whose monomials have a bounded degree. Its elements still have a finite degree and are therefore somewhat like polynomials, but it is possible for instance to take the sum of all indeterminates, which is not a polynomial. A ring of this kind plays a role in constructing the ring of symmetric functions.



Generalized exponents



A simple generalization only changes the set from which the exponents on the variable are drawn. The formulas for addition and multiplication make sense as long as one can add exponents: Xi · Xj = Xi+j. A set for which addition makes sense (is closed and associative) is called a monoid. The set of functions from a monoid N to a ring R which are nonzero at only finitely many places can be given the structure of a ring known as R[N], the monoid ring of N with coefficients in R. The addition is defined component-wise, so that if c = a + b, then cn = an + bn for every n in N. The multiplication is defined as the Cauchy product, so that if c = a · b, then for each n in N, cn is the sum of all aibj where i, j range over all pairs of elements of N which sum to n.


When N is commutative, it is convenient to denote the function a in R[N] as the formal sum:


∑n∈NanXndisplaystyle sum _nin Na_nX^nsum _nin Na_nX^n

and then the formulas for addition and multiplication are the familiar:


(∑n∈NanXn)+(∑n∈NbnXn)=∑n∈N(an+bn)Xndisplaystyle left(sum _nin Na_nX^nright)+left(sum _nin Nb_nX^nright)=sum _nin N(a_n+b_n)X^nleft(sum _nin Na_nX^nright)+left(sum _nin Nb_nX^nright)=sum _nin N(a_n+b_n)X^n

and


(∑n∈NanXn)⋅(∑n∈NbnXn)=∑n∈N(∑i+j=naibj)Xndisplaystyle left(sum _nin Na_nX^nright)cdot left(sum _nin Nb_nX^nright)=sum _nin Nleft(sum _i+j=na_ib_jright)X^nleft(sum _nin Na_nX^nright)cdot left(sum _nin Nb_nX^nright)=sum _nin Nleft(sum _i+j=na_ib_jright)X^n

where the latter sum is taken over all i, j in N that sum to n.


Some authors such as (Lang 2002, II,§3) go so far as to take this monoid definition as the starting point, and regular single variable polynomials are the special case where N is the monoid of non-negative integers. Polynomials in several variables simply take N to be the direct product of several copies of the monoid of non-negative integers.


Several interesting examples of rings and groups are formed by taking N to be the additive monoid of non-negative rational numbers, (Osbourne 2000, §4.4). See also Puiseux series.



Power series



Power series generalize the choice of exponent in a different direction by allowing infinitely many nonzero terms. This requires various hypotheses on the monoid N used for the exponents, to ensure that the sums in the Cauchy product are finite sums. Alternatively, a topology can be placed on the ring, and then one restricts to convergent infinite sums. For the standard choice of N, the non-negative integers, there is no trouble, and the ring of formal power series is defined as the set of functions from N to a ring R with addition component-wise, and multiplication given by the Cauchy product. The ring of power series can be seen as the completion of the polynomial ring.



Noncommutative polynomial rings



For polynomial rings of more than one variable, the products X·Y and Y·X are simply defined to be equal. A more general notion of polynomial ring is obtained when the distinction between these two formal products is maintained. Formally, the polynomial ring in n noncommuting variables with coefficients in the ring R is the monoid ring R[N], where the monoid N is the free monoid on n letters, also known as the set of all strings over an alphabet of n symbols, with multiplication given by concatenation. Neither the coefficients nor the variables need commute amongst themselves, but the coefficients and variables commute with each other.


Just as the polynomial ring in n variables with coefficients in the commutative ring R is the free commutative R-algebra of rank n, the noncommutative polynomial ring in n variables with coefficients in the commutative ring R is the free associative, unital R-algebra on n generators, which is noncommutative when n > 1.



Differential and skew-polynomial rings



Other generalizations of polynomials are differential and skew-polynomial rings.


A differential polynomial ring is a ring of differential operators formed from a ring R and a derivation δ of R into R. This derivation operates on R, and will be denoted X, when viewed as an operator. The elements of R also operate on R by multiplication. The composition of operators is denoted as the usual multiplication. It follows that the relation δ(ab) = (b) + δ(a)b may be rewritten
as


X⋅a=a⋅X+δ(a).displaystyle Xcdot a=acdot X+delta (a).Xcdot a=acdot X+delta (a).

This relation may be extended to define a skew multiplication between two polynomials in X with coefficients in R, which make them a non-commutative ring.


The standard example, called a Weyl algebra, takes R to be a (usual) polynomial ring k[Y], and δ to be the standard polynomial derivative ∂∂Ydisplaystyle tfrac partial partial Ytfrac partial partial Y. Taking a =Y in the above relation, one gets the canonical commutation relation, X·YY·X = 1. Extending this relation by associativity and distributivity allows explicitly constructing the Weyl algebra.(Lam 2001, §1,ex1.9).


The skew-polynomial ring is defined similarly for a ring R and a ring endomorphism f of R, by extending the multiplication from the relation X·r = f(rX to produce an associative multiplication that distributes over the standard addition. More generally, given a homomorphism F from the monoid N of the positive integers into the endomorphism ring of R, the formula Xn·r = F(n)(rXn allows constructing a skew-polynomial ring.(Lam 2001, §1,ex 1.11) Skew polynomial rings are closely related to crossed product algebras.



See also


  • Additive polynomial

  • Laurent polynomial


References



  1. ^ Herstein p. 153


  2. ^ Herstein, Hall p. 73


  3. ^ Lang p. 97


  4. ^ Herstein p. 154


  5. ^ Lang p.100


  6. ^ Anton, Howard; Bivens, Irl C.; Davis, Stephen (2012), Calculus Single Variable, John Wiley & Sons, p. 31, ISBN 9780470647707.mw-parser-output cite.citationfont-style:inherit.mw-parser-output qquotes:"""""""'""'".mw-parser-output code.cs1-codecolor:inherit;background:inherit;border:inherit;padding:inherit.mw-parser-output .cs1-lock-free abackground:url("//upload.wikimedia.org/wikipedia/commons/thumb/6/65/Lock-green.svg/9px-Lock-green.svg.png")no-repeat;background-position:right .1em center.mw-parser-output .cs1-lock-limited a,.mw-parser-output .cs1-lock-registration abackground:url("//upload.wikimedia.org/wikipedia/commons/thumb/d/d6/Lock-gray-alt-2.svg/9px-Lock-gray-alt-2.svg.png")no-repeat;background-position:right .1em center.mw-parser-output .cs1-lock-subscription abackground:url("//upload.wikimedia.org/wikipedia/commons/thumb/a/aa/Lock-red-alt-2.svg/9px-Lock-red-alt-2.svg.png")no-repeat;background-position:right .1em center.mw-parser-output .cs1-subscription,.mw-parser-output .cs1-registrationcolor:#555.mw-parser-output .cs1-subscription span,.mw-parser-output .cs1-registration spanborder-bottom:1px dotted;cursor:help.mw-parser-output .cs1-hidden-errordisplay:none;font-size:100%.mw-parser-output .cs1-visible-errorfont-size:100%.mw-parser-output .cs1-subscription,.mw-parser-output .cs1-registration,.mw-parser-output .cs1-formatfont-size:95%.mw-parser-output .cs1-kern-left,.mw-parser-output .cs1-kern-wl-leftpadding-left:0.2em.mw-parser-output .cs1-kern-right,.mw-parser-output .cs1-kern-wl-rightpadding-right:0.2em.


  7. ^ Sendra, J. Rafael; Winkler, Franz; Pérez-Diaz, Sonia (2007), Rational Algebraic Curves: A Computer Algebra Approach, Algorithms and Computation in Mathematics, 22, Springer, p. 250, ISBN 9783540737247.


  8. ^ Eves, Howard Whitley (1980), Elementary Matrix Theory, Dover, p. 183, ISBN 9780486150277.


  9. ^ Herstein p.155, 162


  10. ^ Herstein p.162


  11. ^ Fröhlich, A.; Shepherson, J. C. (1955), "On the factorisation of polynomials in a finite number of steps", Mathematische Zeitschrift, 62 (1): 331–334, doi:10.1007/BF01180640, ISSN 0025-5874



  • Hall, F. M. (1969). "Section 3.6". An Introduction to Abstract Algebra. 2. Cambridge University Press. ISBN 0521084849.


  • Herstein, I. N. (1975). "Section 3.9". Topics in Algebra. Wiley. ISBN 0471010901.


  • Lam, Tsit-Yuen (2001), A First Course in Noncommutative Rings, Berlin, New York: Springer-Verlag, ISBN 978-0-387-95325-0


  • Lang, Serge (2002), Algebra, Graduate Texts in Mathematics, 211 (Revised third ed.), New York: Springer-Verlag, ISBN 978-0-387-95385-4, MR 1878556


  • Osborne, M. Scott (2000), Basic homological algebra, Graduate Texts in Mathematics, 196, Berlin, New York: Springer-Verlag, doi:10.1007/978-1-4612-1278-2, ISBN 978-0-387-98934-1, MR 1757274


這個網誌中的熱門文章

Barbados

How to read a connectionString WITH PROVIDER in .NET Core?

Node.js Script on GitHub Pages or Amazon S3