Hensel's lemma

From HandWiki
Short description: Result in modular arithmetic

In mathematics, Hensel's lemma, also known as Hensel's lifting lemma, named after Kurt Hensel, is a result in modular arithmetic, stating that if a univariate polynomial has a simple root modulo a prime number p, then this root can be lifted to a unique root modulo any higher power of p. More generally, if a polynomial factors modulo p into two coprime polynomials, this factorization can be lifted to a factorization modulo any higher power of p (the case of roots corresponds to the case of degree 1 for one of the factors).

By passing to the "limit" (in fact this is an inverse limit) when the power of p tends to infinity, it follows that a root or a factorization modulo p can be lifted to a root or a factorization over the p-adic integers.

These results have been widely generalized, under the same name, to the case of polynomials over an arbitrary commutative ring, where p is replaced by an ideal, and "coprime polynomials" means "polynomials that generate an ideal containing 1".

Hensel's lemma is fundamental in p-adic analysis, a branch of analytic number theory.

The proof of Hensel's lemma is constructive, and leads to an efficient algorithm for Hensel lifting, which is fundamental for factoring polynomials, and gives the most efficient known algorithm for exact linear algebra over the rational numbers.

Modular reduction and lifting

Hensel's original lemma concerns the relation between polynomial factorization over the integers and over the integers modulo a prime number p and its powers. It can be straightforwardly extended to the case where the integers are replaced by any commutative ring, and p is replaced by any maximal ideal (indeed, the maximal ideals of have the form p, where p is a prime number).

Making this precise requires a generalization of the usual modular arithmetic, and so it is useful to define accurately the terminology that is commonly used in this context.

Let R be a commutative ring, and I an ideal of R. Reduction modulo I refers to the replacement of every element of R by its image under the canonical map RR/I. For example, if fR[X] is a polynomial with coefficients in R, its reduction modulo I, denoted fmodI, is the polynomial in (R/I)[X]=R[X]/IR[X] obtained by replacing the coefficients of f by their image in R/I. Two polynomials f and g in R[X] are congruent modulo I, denoted fg(modI) if they have the same coefficients modulo I, that is if fgIR[X]. If hR[X], a factorization of h modulo I consists in two (or more) polynomials f, g in R[X] such that hfg(modI).

The lifting process is the inverse of reduction. That is, given objects depending on elements of R/I, the lifting process replaces these elements by elements of R (or of R/Ik for some k > 1) that maps to them in a way that keeps the properties of the objects.

For example, given a polynomial hR[X] and a factorization modulo I expressed as hfg(modI), lifting this factorization modulo Ik consists of finding polynomials f,gR[X] such that ff(modI), gg(modI), and hfg(modIk). Hensel's lemma asserts that such a lifting is always possible under mild conditions; see next section.

Statement

Originally, Hensel's lemma was stated (and proved) for lifting a factorization modulo a prime number p of a polynomial over the integers to a factorization modulo any power of p and to a factorization over the p-adic integers. This can be generalized easily, with the same proof to the case where the integers are replaced by any commutative ring, the prime number is replaced by a maximal ideal, and the p-adic integers are replaced by the completion with respect to the maximal ideal. It is this generalization, which is also widely used, that is presented here.

Let 𝔪 be a maximal ideal of a commutative ring R, and

h=α0Xn++αn1X+αn

be a polynomial in R[X] with a leading coefficient α0 not in 𝔪.

Since 𝔪 is a maximal ideal, the quotient ring R/𝔪 is a field, and (R/𝔪)[X] is a principal ideal domain, and, in particular, a unique factorization domain, which means that every nonzero polynomial in (R/𝔪)[X] can be factorized in a unique way as the product of a nonzero element of (R/𝔪) and irreducible polynomials that are monic (that is, their leading coefficients are 1).

Hensel's lemma asserts that every factorization of h modulo 𝔪 into coprime polynomials can be lifted in a unique way into a factorization modulo 𝔪k for every k.

More precisely, with the above hypotheses, if hα0fg(mod𝔪), where f and g are monic and coprime modulo 𝔪, then, for every positive integer k there are monic polynomials fk and gk such that

hα0fkgk(mod𝔪k),fkf(mod𝔪),gkg(mod𝔪),

and fk and gk are unique (with these properties) modulo 𝔪k.

Lifting simple roots

An important special case is when f=Xr. In this case the coprimality hypothesis means that r is a simple root of hmod𝔪. This gives the following special case of Hensel's lemma, which is often called also Hensel's lemma.

With above hypotheses and notations, if r is a simple root of hmod𝔪, then r can be lifted in a unique way to a simple root of hmod𝔪n for every positive integer n. Explicitly, for every positive integer n, there is a unique rnR/𝔪n such that rnr(mod𝔪) and rn is a simple root of hmod𝔪n.

Lifting to adic completion

The fact that one can lift to R/𝔪n for every positive integer n suggests to "pass to the limit" when n tends to the infinity. This was one of the main motivations for introducing p-adic integers.

Given a maximal ideal 𝔪 of a commutative ring R, the powers of 𝔪 form a basis of open neighborhoods for a topology on R, which is called the 𝔪-adic topology. The completion of this topology can be identified with the completion of the local ring R𝔪, and with the inverse limit limR/𝔪n. This completion is a complete local ring, generally denoted R^𝔪. When R is the ring of the integers, and 𝔪=p, where p is a prime number, this completion is the ring of p-adic integers p.

The definition of the completion as an inverse limit, and the above statement of Hensel's lemma imply that every factorization into pairwise coprime polynomials modulo 𝔪 of a polynomial hR[X] can be uniquely lifted to a factorization of the image of h in R^𝔪[X]. Similarly, every simple root of h modulo 𝔪 can be lifted to a simple root of the image of h in R^𝔪[X].

Proof

Hensel's lemma is generally proved incrementally by lifting a factorization over R/𝔪n to either a factorization over R/𝔪n+1 (Linear lifting), or a factorization over R/𝔪2n (Quadratic lifting).

The main ingredient of the proof is that coprime polynomials over a field satisfy Bézout's identity. That is, if f and g are coprime univariate polynomials over a field (here R/𝔪), there are polynomials a and b such that dega<degg, degb<degf, and

af+bg=1.

Bézout's identity allows defining coprime polynomials and proving Hensel's lemma, even if the ideal 𝔪 is not maximal. Therefore, in the following proofs, one starts from a commutative ring R, an ideal I, a polynomial hR[X] that has a leading coefficient that is invertible modulo I (that is its image in R/I is a unit in R/I), and factorization of h modulo I or modulo a power of I, such that the factors satisfy a Bézout's identity modulo I. In these proofs, AB(modI) means ABIR[X].

Linear lifting

Let I be an ideal of a commutative ring R, and hR[X] be a univariate polynomial with coefficients in R that has a leading coefficient α that is invertible modulo I (that is, the image of α in R/I is a unit in R/I).

Suppose that for some positive integer k there is a factorization

hαfg(modIk),

such that f and g are monic polynomials that are coprime modulo I, in the sense that there exist a,bR[X], such that af+bg1(modI). Then, there are polynomials δf,δgIkR[X], such that degδf<degf, degδg<degg, and

hα(f+δf)(g+δg)(modIk+1).

Under these conditions, δf and δg are unique modulo Ik+1R[X].

Moreover, f+δf and g+δg satisfy the same Bézout's identity as f and g, that is, a(f+δf)+b(g+δg)1(modI). This follows immediately from the preceding assertions, but is needed to apply iteratively the result with increasing values of k.

The proof that follows is written for computing δf and δg by using only polynomials with coefficients in R/I or Ik/Ik+1. When R= and I=p, this allows manipulating only integers modulo p.

Proof: By hypothesis, α is invertible modulo I. This means that there exists βR and γIR[X] such that αβ=1γ.

Let δhIkR[X], of degree less than degh, such that

δhhαfg(modIk+1).

(One may choose δh=hαfg, but other choices may lead to simpler computations. For example, if R= and I=p, it is possible and better to choose δh=pkδ'h where the coefficients of δ'h are integers in the interval [0,p1].)

As g is monic, the Euclidean division of aδh by g is defined, and provides q and c such that aδh=qg+c, and degc<degg. Moreover, both q and c are in IkR[X]. Similarly, let bδh=qf+d, with degd<degf, and q,dIkR[X].

One has q+qIk+1R[X]. Indeed, one has

fc+gd=afδh+bgδhfg(q+q)δhfg(q+q)(modIk+1).

As fg is monic, the degree modulo Ik+1 of fg(q+q) can be less than degfg only if q+qIk+1R[X].

Thus, considering congruences modulo Ik+1, one has

α(f+βd)(g+βc)hαfgh+αβ(f(aδhqg)+g(bδhqf))δh(1+αβ(af+bg))αβfg(q+q)0(modIk+1).

So, the existence assertion is verified with

δf=βd,δg=βc.

Uniqueness

Let R, I, h and α as a in the preceding section. Let

hαfg(modI)

be a factorization into coprime polynomials (in the above sense), such degf0+degg0=degh. The application of linear lifting for k=1,2,,n1, shows the existence of δf and δg such that degδf<degf, degδg<degg, and

hα(f+δf)(g+δg)(modIn).

The polynomials δf and δg are uniquely defined modulo In. This means that, if another pair (δ'f,δ'g) satisfies the same conditions, then one has

δ'fδf(modIn)andδ'gδg(modIn).

Proof: Since a congruence modulo In implies the same concruence modulo In1, one can proceed by induction and suppose that the uniqueness has been proved for n − 1, the case n = 0 being trivial. That is, one can suppose that

δfδ'fIn1R[X]andδgδ'gIn1R[X].

By hypothesis, has

hα(f+δf)(g+δg)α(f+δ'f)(g+δ'g)(modIn),

and thus

α(f+δf)(g+δg)α(f+δ'f)(g+δ'g)=α(f(δgδ'g)+g(δfδ'f))+α(δf(δgδ'g)δg(δfδ'f))InR[X].

By induction hypothesis, the second term of the latter sum belongs to In, and the same is thus true for the first term. As α is invertible modulo I, there exist βR and γI such that αβ=1+γ. Thus

f(δgδ'g)+g(δfδ'f)=αβ(f(δgδ'g)+g(δfδ'f))γ(f(δgδ'g)+g(δfδ'f))InR[X],

using the induction hypothesis again.

The coprimality modulo I implies the existence of a,bR[X] such that 1af+bg(modI). Using the induction hypothesis once more, one gets

δgδ'g(af+bg)(δgδ'g)g(b(δgδ'g)a(δfδ'f))(modIn).

Thus one has a polynomial of degree less than degg that is congruent modulo In to the product of the monic polynomial g and another polynomial w. This is possible only if wInR[X], and implies δgδ'gInR[X]. Similarly, δfδ'f is also in InR[X], and this proves the uniqueness.

Quadratic lifting

Linear lifting allows lifting a factorization modulo In to a factorization modulo In+1. Quadratic lifting allows lifting directly to a factorization modulo I2n, at the cost of lifting also the Bézout's identity and of computing modulo In instead of modulo I (if one uses the above description of linear lifting).

For lifting up to modulo IN for large N one can use either method. If, say, N=2k, a factorization modulo IN requires N − 1 steps of linear lifting or only k − 1 steps of quadratic lifting. However, in the latter case the size of the coefficients that have to be manipulated increase during the computation. This implies that the best lifting method depends on the context (value of N, nature of R, multiplication algorithm that is used, hardware specificities, etc.).[citation needed]

Quadratic lifting is based on the following property.

Suppose that for some positive integer k there is a factorization

hαfg(modIk),

such that f and g are monic polynomials that are coprime modulo I, in the sense that there exist a,bR[X], such that af+bg1(modIk). Then, there are polynomials δf,δgIkR[X], such that degδf<degf, degδg<degg, and

hα(f+δf)(g+δg)(modI2k).

Moreover, f+δf and g+δg satisfy a Bézout's identity of the form

(a+δa)(f+δf)+(b+δb)(g+δg)1(modI2k).

(This is required for allowing iterations of quadratic lifting.)

Proof: The first assertion is exactly that of linear lifting applied with k = 1 to the ideal Ik instead of I.

Let α=af+bg1IkR[X]. One has

a(f+δf)+b(g+δg)=1+Δ,

where

Δ=α+aδf+bδgIkR[X].

Setting δa=aΔ and δb=bΔ, one gets

(a+δa)(f+δf)+(b+δb)(g+δg)=1Δ2I2kR[X],

which proves the second assertion.

Explicit example

Let f(X)=X62[X].

Modulo 2, Hensel's lemma cannot be applied since the reduction of f(X) modulo 2 is simply[1]pg 15-16

f¯(X)=X62=X6

with 6 factors X not being relatively prime to each other. By Eisenstein's criterion, however, one can conclude that the polynomial f(X) is irreducible in 2[X].
Over k=𝔽7, on the other hand, one has

f¯(X)=X62=X616=(X34)(X3+4)

where 4 is the square root of 2 in 𝔽7. As 4 is not a cube in 𝔽7, these two factors are irreducible over 𝔽7. Hence the complete factorization of X62 in 7[X] and 7[X] is

f(X)=X62=(X3α)(X3+α),

where α=4504547 is a square root of 2 in 7 that can be obtained by lifting the above factorization.
Finally, in 𝔽727[X] the polynomial splits into

f¯(X)=X62=(X3)(X116)(X119)(X608)(X611)(X724)

with all factors relatively prime to each other, so that in 727[X] and 727[X] there are 6 factors Xβ with the (non-rational) 727-adic integers

β={3+545727+5377272+1617273+116+48727+1307272+4987273+119+593727+6677272+6597273+608+133727+597272+677273+611+678727+5967272+2287273+724+181727+1897272+5657273+

Using derivatives for lifting roots

Let f(x) be a polynomial with integer (or p-adic integer) coefficients, and let m, k be positive integers such that mk. If r is an integer such that

f(r)0modpkandf(r)≢0modp

then, for every m>0 there exists an integer s such that

f(s)0modpk+mandrsmodpk.

Furthermore, this s is unique modulo pk+m, and can be computed explicitly as the integer such that

s=rf(r)a,

where a is an integer satisfying

a[f(r)]1modpm.

Note that f(r)0modpk so that the condition srmodpk is met. As an aside, if f(r)0modp, then 0, 1, or several s may exist (see Hensel Lifting below).

Derivation

We use the Taylor expansion of f around r to write:

f(s)=n=0Ncn(sr)n,cn=f(n)(r)/n!.

From rsmodpk, we see that sr = tpk for some integer t. Let

f(s)=n=0Ncn(tpk)n=f(r)+tpkf(r)+n=2Ncntnpkn=f(r)+tpkf(r)+p2kt2g(t)g(t)[t]=zpk+tpkf(r)+p2kt2g(t)f(r)0modpk=(z+tf(r))pk+p2kt2g(t)

For mk, we have:

f(s)0modpk+m(z+tf(r))pk0modpk+mz+tf(r)0modpmtf(r)zmodpmtz[f(r)]1modpmpf(r)

The assumption that f(r) is not divisible by p ensures that f(r) has an inverse mod pm which is necessarily unique. Hence a solution for t exists uniquely modulo pm, and s exists uniquely modulo pk+m.

Observations

Criterion for irreducible polynomials

Using the above hypotheses, if we consider an irreducible polynomial

f(x)=a0+a1x++anxnK[X]

such that a0,an0, then

|f|=max{|a0|,|an|}

In particular, for f(X)=X6+10X1, we find in 2[X]

|f(X)|=max{|a0|,,|an|}=max{0,1,0}=1

but max{|a0|,|an|}=0, hence the polynomial cannot be irreducible. Whereas in 7[X] we have both values agreeing, meaning the polynomial could be irreducible. In order to determine irreducibility, the Newton polygon must be employed.[2]:{{{1}}}

Frobenius

Note that given an a𝔽p the Frobenius endomorphism yyp gives a nonzero polynomial xpa that has zero derivative

ddx(xpa)=pxp10xp1modp0modp

hence the pth roots of a do not exist in p. For a=1, this implies that p cannot contain the root of unity μp.

Roots of unity

Although the pth roots of unity are not contained in 𝔽p, there are solutions of xpx=x(xp11). Note that

ddx(xpx)=pxp111modp

is never zero, so if there exists a solution, it necessarily lifts to p. Because the Frobenius gives ap=a, all of the non-zero elements 𝔽p× are solutions. In fact, these are the only roots of unity contained in p.[3]

Hensel lifting

Using the lemma, one can "lift" a root r of the polynomial f modulo pk to a new root s modulo pk+1 such that rs mod pk (by taking m = 1; taking larger m follows by induction). In fact, a root modulo pk+1 is also a root modulo pk, so the roots modulo pk+1 are precisely the liftings of roots modulo pk. The new root s is congruent to r modulo p, so the new root also satisfies f(s)f(r)≢0modp. So the lifting can be repeated, and starting from a solution rk of f(x)0modpk we can derive a sequence of solutions rk+1, rk+2, ... of the same congruence for successively higher powers of p, provided that f(rk)≢0modp for the initial root rk. This also shows that f has the same number of roots mod pk as mod pk+1, mod pk+2, or any other higher power of p, provided that the roots of f mod pk are all simple.

What happens to this process if r is not a simple root mod p? Suppose that

f(r)0modpkandf(r)0modp.

Then srmodpk implies f(s)f(r)modpk+1. That is, f(r+tpk)f(r)modpk+1 for all integers t. Therefore, we have two cases:

  • If f(r)≢0modpk+1 then there is no lifting of r to a root of f(x) modulo pk+1.
  • If f(r)0modpk+1 then every lifting of r to modulus pk+1 is a root of f(x) modulo pk+1.

Example. To see both cases we examine two different polynomials with p = 2:

f(x)=x2+1 and r = 1. Then f(1)0mod2 and f(1)0mod2. We have f(1)≢0mod4 which means that no lifting of 1 to modulus 4 is a root of f(x) modulo 4.

g(x)=x217 and r = 1. Then g(1)0mod2 and g(1)0mod2. However, since g(1)0mod4, we can lift our solution to modulus 4 and both lifts (i.e. 1, 3) are solutions. The derivative is still 0 modulo 2, so a priori we don't know whether we can lift them to modulo 8, but in fact we can, since g(1) is 0 mod 8 and g(3) is 0 mod 8, giving solutions at 1, 3, 5, and 7 mod 8. Since of these only g(1) and g(7) are 0 mod 16 we can lift only 1 and 7 to modulo 16, giving 1, 7, 9, and 15 mod 16. Of these, only 7 and 9 give g(x) = 0 mod 32, so these can be raised giving 7, 9, 23, and 25 mod 32. It turns out that for every integer k ≥ 3, there are four liftings of 1 mod 2 to a root of g(x) mod 2k.

Hensel's lemma for p-adic numbers

In the p-adic numbers, where we can make sense of rational numbers modulo powers of p as long as the denominator is not a multiple of p, the recursion from rk (roots mod pk) to rk+1 (roots mod pk+1) can be expressed in a much more intuitive way. Instead of choosing t to be an(y) integer which solves the congruence

tf(rk)(f(rk)/pk)modpm,

let t be the rational number (the pk here is not really a denominator since f(rk) is divisible by pk):

(f(rk)/pk)/f(rk).

Then set

rk+1=rk+tpk=rkf(rk)f(rk).

This fraction may not be an integer, but it is a p-adic integer, and the sequence of numbers rk converges in the p-adic integers to a root of f(x) = 0. Moreover, the displayed recursive formula for the (new) number rk+1 in terms of rk is precisely Newton's method for finding roots to equations in the real numbers.

By working directly in the p-adics and using the p-adic absolute value, there is a version of Hensel's lemma which can be applied even if we start with a solution of f(a) ≡ 0 mod p such that f(a)0modp. We just need to make sure the number f(a) is not exactly 0. This more general version is as follows: if there is an integer a which satisfies:

|f(a)|p<|f(a)|p2,

then there is a unique p-adic integer b such f(b) = 0 and |ba|p<|f(a)|p. The construction of b amounts to showing that the recursion from Newton's method with initial value a converges in the p-adics and we let b be the limit. The uniqueness of b as a root fitting the condition |ba|p<|f(a)|p needs additional work.

The statement of Hensel's lemma given above (taking m=1) is a special case of this more general version, since the conditions that f(a) ≡ 0 mod p and f(a)≢0modp say that |f(a)|p<1 and |f(a)|p=1.

Examples

Suppose that p is an odd prime and a is a non-zero quadratic residue modulo p. Then Hensel's lemma implies that a has a square root in the ring of p-adic integers p. Indeed, let f(x)=x2a. If r is a square root of a modulo p then:

f(r)=r2a0modpandf(r)=2r≢0modp,

where the second condition is dependent on the fact that p is odd. The basic version of Hensel's lemma tells us that starting from r1 = r we can recursively construct a sequence of integers {rk} such that:

rk+1rkmodpk,rk2amodpk.

This sequence converges to some p-adic integer b which satisfies b2 = a. In fact, b is the unique square root of a in p congruent to r1 modulo p. Conversely, if a is a perfect square in p and it is not divisible by p then it is a nonzero quadratic residue mod p. Note that the quadratic reciprocity law allows one to easily test whether a is a nonzero quadratic residue mod p, thus we get a practical way to determine which p-adic numbers (for p odd) have a p-adic square root, and it can be extended to cover the case p = 2 using the more general version of Hensel's lemma (an example with 2-adic square roots of 17 is given later).

To make the discussion above more explicit, let us find a "square root of 2" (the solution to x22=0) in the 7-adic integers. Modulo 7 one solution is 3 (we could also take 4), so we set r1=3. Hensel's lemma then allows us to find r2 as follows:

f(r1)=322=7f(r1)/p1=7/7=1f(r1)=2r1=6

Based on which the expression

tf(r1)(f(r1)/pk)modp,

turns into:

t61mod7

which implies t=1. Now:

r2=r1+tp1=3+17=10=137.

And sure enough, 1022mod72. (If we had used the Newton method recursion directly in the 7-adics, then r2=r1f(r1)/f(r1)=37/6=11/6, and 11/610mod72.)

We can continue and find r3=108=3+7+272=2137. Each time we carry out the calculation (that is, for each successive value of k), one more base 7 digit is added for the next higher power of 7. In the 7-adic integers this sequence converges, and the limit is a square root of 2 in 7 which has initial 7-adic expansion

3+7+272+673+74+275+76+277+478+.

If we started with the initial choice r1=4 then Hensel's lemma would produce a square root of 2 in 7 which is congruent to 4 (mod 7) instead of 3 (mod 7) and in fact this second square root would be the negative of the first square root (which is consistent with 4 = −3 mod 7).

As an example where the original version of Hensel's lemma is not valid but the more general one is, let f(x)=x217 and a=1. Then f(a)=16 and f(a)=2, so

|f(a)|2<|f(a)|22,

which implies there is a unique 2-adic integer b satisfying

b2=17and|ba|2<|f(a)|2=12,

i.e., b ≡ 1 mod 4. There are two square roots of 17 in the 2-adic integers, differing by a sign, and although they are congruent mod 2 they are not congruent mod 4. This is consistent with the general version of Hensel's lemma only giving us a unique 2-adic square root of 17 that is congruent to 1 mod 4 rather than mod 2. If we had started with the initial approximate root a = 3 then we could apply the more general Hensel's lemma again to find a unique 2-adic square root of 17 which is congruent to 3 mod 4. This is the other 2-adic square root of 17.

In terms of lifting the roots of x217 from modulus 2k to 2k+1, the lifts starting with the root 1 mod 2 are as follows:

1 mod 2 → 1, 3 mod 4
1 mod 4 → 1, 5 mod 8 and 3 mod 4 → 3, 7 mod 8
1 mod 8 → 1, 9 mod 16 and 7 mod 8 → 7, 15 mod 16, while 3 mod 8 and 5 mod 8 don't lift to roots mod 16
9 mod 16 → 9, 25 mod 32 and 7 mod 16 → 7, 23 mod 16, while 1 mod 16 and 15 mod 16 don't lift to roots mod 32.

For every k at least 3, there are four roots of x2 − 17 mod 2k, but if we look at their 2-adic expansions we can see that in pairs they are converging to just two 2-adic limits. For instance, the four roots mod 32 break up into two pairs of roots which each look the same mod 16:

9 = 1 + 23 and 25 = 1 + 23 + 24.
7 = 1 + 2 + 22 and 23 = 1 + 2 + 22 + 24.

The 2-adic square roots of 17 have expansions

1+23+25+26+27+29+210+
1+2+22+24+28+211+

Another example where we can use the more general version of Hensel's lemma but not the basic version is a proof that any 3-adic integer c ≡ 1 mod 9 is a cube in 3. Let f(x)=x3c and take initial approximation a = 1. The basic Hensel's lemma cannot be used to find roots of f(x) since f(r)0mod3 for every r. To apply the general version of Hensel's lemma we want |f(1)|3<|f(1)|32, which means c1mod27. That is, if c ≡ 1 mod 27 then the general Hensel's lemma tells us f(x) has a 3-adic root, so c is a 3-adic cube. However, we wanted to have this result under the weaker condition that c ≡ 1 mod 9. If c ≡ 1 mod 9 then c ≡ 1, 10, or 19 mod 27. We can apply the general Hensel's lemma three times depending on the value of c mod 27: if c ≡ 1 mod 27 then use a = 1, if c ≡ 10 mod 27 then use a = 4 (since 4 is a root of f(x) mod 27), and if c ≡ 19 mod 27 then use a = 7. (It is not true that every c ≡ 1 mod 3 is a 3-adic cube, e.g., 4 is not a 3-adic cube since it is not a cube mod 9.)

In a similar way, after some preliminary work, Hensel's lemma can be used to show that for any odd prime number p, any p-adic integer c congruent to 1 modulo p2 is a p-th power in p. (This is false for p = 2.)

Generalizations

Suppose A is a commutative ring, complete with respect to an ideal 𝔪, and let f(x)A[x]. aA is called an "approximate root" of f, if

f(a)0modf(a)2𝔪.

If f has an approximate root then it has an exact root bA "close to" a; that is,

f(b)=0andbamod𝔪.

Furthermore, if f(a) is not a zero-divisor then b is unique.

This result can be generalized to several variables as follows:

Theorem. Let A be a commutative ring that is complete with respect to ideal 𝔪A. Let f1,,fnA[x1,,xn] be a system of n polynomials in n variables over A. View 𝐟=(f1,,fn), as a mapping from An to itself, and let J𝐟(𝐱) denote its Jacobian matrix. Suppose a = (a1, ..., an) ∈ An is an approximate solution to f = 0 in the sense that
fi(𝐚)0mod(detJ𝐟(a))2𝔪,1in.
Then there is some b = (b1, ..., bn) ∈ An satisfying f(b) = 0, i.e.,
fi(𝐛)=0,1in.
Furthermore this solution is "close" to a in the sense that
biaimoddetJ𝐟(a)𝔪,1in.

As a special case, if fi(𝐚)0mod𝔪 for all i and detJ𝐟(𝐚) is a unit in A then there is a solution to f(b) = 0 with biaimod𝔪 for all i.

When n = 1, a = a is an element of A and J𝐟(𝐚)=Jf(a)=f(a). The hypotheses of this multivariable Hensel's lemma reduce to the ones which were stated in the one-variable Hensel's lemma.

Completeness of a ring is not a necessary condition for the ring to have the Henselian property: Goro Azumaya in 1950 defined a commutative local ring satisfying the Henselian property for the maximal ideal m to be a Henselian ring.

Masayoshi Nagata proved in the 1950s that for any commutative local ring A with maximal ideal m there always exists a smallest ring Ah containing A such that Ah is Henselian with respect to mAh. This Ah is called the Henselization of A. If A is noetherian, Ah will also be noetherian, and Ah is manifestly algebraic as it is constructed as a limit of étale neighbourhoods. This means that Ah is usually much smaller than the completion  while still retaining the Henselian property and remaining in the same category[clarification needed].

See also

References