• No results found

Standardconstructionforcertainfinitefields BachelorThesis

N/A
N/A
Protected

Academic year: 2021

Share "Standardconstructionforcertainfinitefields BachelorThesis"

Copied!
18
0
0

Bezig met laden.... (Bekijk nu de volledige tekst)

Hele tekst

(1)

Bachelor Thesis

Standard construction for certain finite fields

Author:

J.E.F. Rood math@jobrood.nl

Supervisor:

Dr. B. de Smit

March 23, 2015

(2)

1 Introduction

A finite field always has pn elements for some prime number p and a positive number n. Moreover for every prime number p and positive number n there exists a finite field with pn elements. Furthermore any two fields of the same cardinality are isomorphic. For a prime number p and positive integer n a finite field of cardinality p can be represented as Z/pZ and a field of cardinality pn can be constructed as (Z/pZ)[X]/(f) with f ∈ (Z/pZ)[X] a monic irreducible polynomial of degree n.

We are looking for an algorithm such that on input of a prime number p and positive integer n it will give as output a field of cardinality pn. A possible algorithm would be to randomly pick a polynomial of degree n and check if it is irreducible in (Z/pZ)[X]. Such an algorithm is relatively fast, but such an algorithm could produce different output on multiple runs. Another example is the commonly used Conway polynomials, these are defined inductively as the minimal irreducible polynomial of a lexicographical ordering such that the Con- way polynomial cp,nis compatible with the polynomials cp,m for all m dividing n. There are two algorithms to produce such a polynomial cp,n, which results in a deterministic output, but these are also time consuming [8]. We would like an algorithm that combines the best aspect of the previous two examples, it has to be fast and it results in the same output every time it runs on the same input.

De Smit and Lenstra defined an effective construction for a finite field based upon prime ideals instead of polynomials [4]. For this construction there is a probabilistic algorithm that on input of a prime number p and positive integer n carries out the construction in polynomial time [5]. Moreover, it is a randomized algorithm of the type Las Vegas algorithms [10], so for a certain p and n it will always produce the same field. Thus the method of De Smit and Lenstra should combine the aspects we are looking for in the algorithm for a finite field. For some aspects of the method no proof has been published yet.

The purpose of this thesis is to prove for any prime number p and a positive integer n such that gcd(p, n) = 1 that the definition of De Smit and Lenstra defines a construction of a finite field of cardinality pn.

Definition 1. Let r be a prime number and define r := r·gcd(2, r). For i ∈ Z≥0

we define

Ar,i:= Z[X0, X1, X2, ..., Xi]/(

r−1

X

i=0

X0rri; Xjr− Xj−1 : 0 < j ≤ i).

Note that the residue class of Xi is a primitive root ζrri of order rri. Also notice for i ∈ Z≥0 that Ar,i is a ring and that Ar,j ⊂ Ar,i for j < i. Thus we can define Ar as the unionS

i=0Ar,i. In Section 2 we will show that the ring Ar is the ring of integers of the field Q(ζrri: i ≥ 0). Also we will show that the Galois group of Q(ζrri: i ≥ 0) over Q is the unit group Zr of the ring of r-adic integers.

Notation. Denote the torsion subgroup of the Galois group of Q(ζrrj : j > 0) over Q by ∆r.

We will see in Lemma 12 that ∆r is isomorphic to (Z/rZ), which is also isomorphic to the Galois group of Q(ζr) over Q. The group ∆ris cyclic of order ϕ(r) where ϕ denotes the Euler phi function.

(3)

Definition 2. Define Br,k as the set {a ∈ Ar,k|∀δ ∈ ∆r: δ(a) = a} and Bras the unionS

i=0Br,i.

Let p be a prime number. Notice that Br,0 = Z and thus Br,0/pBr,0 is a field of cardinality p. In this thesis we will look for ideals p of the ring Br,k for all k ∈ Z≥0 such that Br,k/pBr,k is a field with characteristic p, in other words prime ideals such that p ∈ p.

Notation. For prime numbers r and p such that p 6= r we will denote the set of prime ideals of Br containingp as Sp,r.

Theorem 3. Let l := ordr

pϕ(r)−1 r/r



, where ordr is ther-adic valuation. The cardinality of Sp,r is rl and for every prime ideal P ∈Sp,r there is a unique prime ideal p of Br,l such that P= p · Br.

This implies that given generators of a prime ideal of Br,l containing p, we will have the generators for a prime ideal in Sp,r.

Definition 4. For i a non-negative integer, k a positive integer and r a prime number let ηr,k,i:=P

δ∈∆rσδrr1+irrk k−1) ∈ Br,k.

We will show that the elements ηr,k,iwith 0 ≤ i < r form a module basis for Br,k[1r] over Br,k−1[1r]. Combining this fact and Theorem 3 we will prove the following theorem.

Theorem 5. For p ∈ Sp,r there is a unique system (ap,j)0≤j<lr of integers ap,j ∈ {0, 1, . . . , p − 1} such that p is generated as a module over Br by p and {ηr,j+1,i− ap,i+jr: 0 ≤ j < l, 0 ≤ i < r}.

As a consequence of Theorem 5 we can define a prime ideal of Br as the smallest in a lexicographical ordering as done in Definition 6.

Definition 6. Let pp,r be the unique prime ideal in Sp,r such that for every prime ideal q in Sp,r there is a j ∈ {0, 1, ..., lr − 1} such that for all i < j we have app,r,i= aq,i and app,r,j ≤ aq,j.

Theorem 7. Denote the prime ideal pp,r∩ Br,i as pp,r,i and letηp,r,k= ηp,r,k

(mod pp,r,k). For all k ≥ 0 the field Fpr,l+k,0) has cardinality prk.

For a non-negative integer k and distinct prime numbers p, r, the field of cardinality prk constructed in Theorem 7 is the standard model for a field of cardinality prk as defined by De Smit and Lenstra.

We conclude this thesis with an argument using tensor products, which proves that the defined construction of De Smit and Lenstra is a construction of a finite field of cardinality pn for p a prime number and n a positive integer such that gcd(p, n) = 1.

(4)

2 Cyclotomic rings

Let r be a prime number and define r := r · gcd(2, r). We consider the ring

Q[X0, X1, X2, ...]/(

r−1

X

i=0

X0rri; Xjr− Xj−1: j > 0).

The residue class ζrri of Xi is a root of unity of order rri. Note that this ring is a field which is generated as a field extension of Q by {ζrrj : j ≥ 0}.

Lemma 8. For n a positive integer, let q = rrn. There is an isomorphism (Z/qZ)→ Gal(Q(ζq)/Q) , such that a 7→ (ζq 7→ ζqa).

Proof. We know ζqq = 1 and ζqj 6= 1 for any 1 ≤ j < q. It follows that for an automorphism σ ∈ Gal(Q(ζq)/Q) the identities σ(ζq)q = 1 and σ(ζq)j 6= 1 hold.

Now σ(ζq) is a root of Xq− 1, but not of Xj− 1 and thus σ(ζq) = ζqa where a is relatively prime to q. Thus there is an injection from Gal(Q(ζq)/Q) to (Z/qZ). Proposition 6.2 (b) in Milne’s course notes [9] gives us that # Gal(Q(ζq)/Q) = ϕ(q) = #(Z/qZ), therefore our injection is even a bijection.

Notation. The cyclic group of m elements we will denote as Cm.

For a prime power q Gauss [6] showed that (Z/qZ) is isomorphic to either the cyclic group Cϕ(q)or the product of two cyclic groups C2and Cq/4depending on q (mod 2), combined with Lemma 8 we find:

Gal(Q(ζq)/Q) ∼=

(C2× Cq/4 if 2|q and q 6= 2, Cϕ(q) else.

Then for q = rrn with n ≥ 0 a positive integer we have # Gal(Q(ζq)/Q) = ϕ(r)rn.

Definition 9. Let K be an algebraic field extension of Q. The ring of integers OK of K is the set of all a ∈ K such that a is a root of a monic polynomial f ∈ Z[X]. For an element x ∈ OK we say it is integral over Z.

From Proposition 6.2 (b) in Milne’s course notes [9] we have that Z[ζq] is the ring of integers of Q(ζq). Thus the ring Ar,i as in Definition 1 is the ring of integers of Q(ζrri).

Lemma 10.

I. For a chain of field extensionsK0⊂ K1⊂ ... we have the identity of rings of integers

Oi≥0Ki= [

i>0

OKi.

II. For an extension of fieldsK ⊂ L with G = Aut(L/K) we have the identity of rings of integers

OGL = OLG.

(5)

Proof. Note that for a chain of field extensions K0⊂ K1⊂ ... we have x ∈ [

i≥0

OKi⇔ there is an i ≥ 0 such that x ∈ OKi

⇔ there is an i ≥ 0 such that x ∈ Ki and x is integral over Z.

⇔ x ∈ [

i≥0

Ki and x is integral over Z.

⇔ x ∈ Oi≥0Ki.

Likewise we have the following equivalences for the fields K ⊂ L with G = Aut(L/K).

x ∈ OLG⇔ x ∈ LG and x is integral over Z.

⇔ x ∈ L and for every σ ∈ G we have σ(x) = x and x is integral over Z.

⇔ x ∈ OGL.

Since the ring Aris defined as the union over the Ar,iit is the ring of integers of the field Q(ζrri : i ≥ 0) by Lemma 10.I. The ring Br,idefined in Definition 2 is the ring of integers of the field Q(ζrrj : 0 ≤ j ≤ i)rby Lemma 10.II and then Br

is the ring of integers of the fieldS

i≥0Q(ζrrj : 0 ≤ j ≤ i)r = Q(ζrj : j ≥ 0)r again by Lemma 10.I.

The Galois group of Q(ζrri : i ≥ 0) over Q is isomorphic to the projective limit lim←−k≥0Gal(Q(ζrrk)/Q) by Theorem 28.14 of Stevenhagen’s course notes [11].

Definition 11. The ring of r-adic numbers is defined as lim←−k≥0Z/rkZ and denoted as Zr.

Notation. For u ∈ Zr, the ring automorphism σu denotes the automorphism in Gal(Q(ζrri : i ≥ 0)/Q) that sends ζrrk to ζrruk for all k ≥ 0 and where u = u (mod rrk) .

Remark. The limit lim←−k≥0(Z/rkZ) is isomorphic to Zr.

Therefore Gal(Q(ζrri: i ≥ 0)/Q) ∼= Zrand thus for every u ∈ Zr there is an unique ring automorphism σu of Ar. The Galois group of Q(ζrri : i ≥ 0) over Q acts as an automorphism group on the ring of integers Arand Z. Recall that

ris defined as the torsion subgroup of Gal(Q(ζrri : i ≥ 0)/Q).

Lemma 12. The group∆r is cyclic of orderϕ(r).

For a proof of this lemma see Corollary 4.5.10 of Gouvea [7].

Corollary 13. The field degree of Q(ζrrj : 0 ≤ j ≤ i)r over Q is ri.

(6)

3 Galois extensions and ring of integers

In this section let K be a finite Galois extension of Q with degree n. Also we say that an ideal I of OK divides another ideal J if J ⊂ I

Lemma 14. Letp be a prime number and P be the set of prime ideals dividing the idealpOK. There are unique integerse, f, g ≥ 1 such that

(1) #P = g,

(2) [OK: Z/pZ] = f for all p ∈ P , (3) sup{i : pi|pOK} = e for all p ∈ P , (4) ef g = n,

(5) pOK =Q

p∈Ppe.

Notation. The number e in the previous Lemma is called the ramification index and the number f is called the residue degree.

Lemma 15. LetL be a Galois extension of K and let q ⊂ OL be a prime ideal, then there is an unique prime ideal p ⊂ OK s.t. p= q ∩ OK.

Lemma 14 and 15 are well known statements from algebraic number theory and a proof can be found in Chapter 8 of Ash [1] or section 3 of Milne [9].

Definition 16. The decomposition group of a prime ideal P of OK is the subgroup DP= {σ ∈ Gal(K/Q) : σ(P) = P} of Gal(K/Q).

Lemma 17. For a given ideal P of OK such thatp ∈ P, the number of elements of DP is equal to the product of the ramification indexe and the residue degree f .

Proof. The Galois group Gal(K/Q) acts transitively on the prime ideals above p as shown in Theorem 8.1. of [11]. Thus the orbit of P contains g elements.

Note that DP is the stabilizer of the prime ideal P and from Lemma 14 and the orbit-stabilizer theorem we find that DP= [K:Q]g = f e.

An element σ ∈ DP naturally induces an element of Gal((OK/P)/Fp), that is the map x + P 7→ σ(x) + P.

Lemma 18. The natural mapDP→ Gal((OK/P)/Fp) is surjective.

For a proof of this lemma see Lemma 8.4. of [11].

Definition 19. The inertia group IPis the kernel of DP→ Gal((OK/P)/Fp).

Thus the induced map DP/Ip→ Gal((OK/P)/Fp) is bijective.

Lemma 20. The number of elements of IP is the ramification indexe.

Proof. The number of elements in Gal((OK/P)/Fp) is f as defined in Lemma 14. Thus because the bijection DP/IP has f elements, while by Lemma 17 the number of elements of DP is f e. Thus #IP= e.

Corollary 21. If the ramification index is 1, then the number of elements in IP is1, thus DP/IP= DP and thereforeDP→ Gal((OK/P)/Fp) is bijective.

In the situation that we can apply this Corollary, we can calculate the residue degree as the order of the decomposition group.

(7)

4 Frobenius

Let K be a finite Galois extension of Q and k ∈ Z≥0 and p a prime number.

Definition 22. For P ⊂ OK a prime ideal of the ring of integers of K such that p ∈ P and the ramification index e = 1, a Frobenius of P is an element σ ∈ AutQ(K) satisfying the following conditions:

(1) σ(P) = P

(2) For every α ∈ OK, σ(α) ≡ αp (mod P).

For a proof of existence see p. 140 of [9]. This map should not be confused with the Frobenius map defined on a finite field.

Notation. For q a power of p, we denote the Frobenius Fq → Fq, x 7→ xp in Gal(Fq/Fp) as F .

Lemma 23. The Frobenius defined in Definition 22 is unique and its order is equal to the residue degreef .

Proof. Let σ be a map satisfying Definition 22 for a prime ideal P ⊂ OK

with ramification index 1. Then σ is an element of DP. Since by assumption the ramification index is 1, we can apply Corollary 21 and thus φ : DP → Gal((OK/P)/Fp) is an isomorphism. Under that isomorphism φ the map σ is sent to the map x + P 7→ σ(x) + P. By the second condition in Definition 22 this is the map F . Thus φ(σ) = F and thus Frobenius of P is unique.

Because F is a generator of Gal((OK/P)/Fp), it has order f . By the iso- morphism φ the Frobenius of P will then also have order f .

Notation. We denote the Frobenius of a prime ideal P as FrobP.

Let p, r be distinct prime numbers and let p be a prime ideal of Br,k such that p ∈ p. For the remainder of the thesis we will use these notations. In order to define a Frobenius of p we need to determine the ramification index of Br,k. Lemma 24. The ramification index over Q of a prime ideal containing p in Ar,i andBr,i is1 for all i ≥ 0.

Proof. In the case of Ar,i see Proposition 6.2 (d) of Milne [9]. In the case of Br,i, let i ∈ Z>0 and assume there is a prime ideal P in Br,i dividing (p) with ramification index e > 1. Let Q ⊂ Ar,i a prime ideal dividing P. Thus Pe|(p) and Q|P and thus Qe|(p). This contradicts our first result and thus every ideal of Br,k containing p has ramification index 1.

Lemma 25. Let q be a prime ideal of Ar,k such that p ∈ q. The map Frobq is the image ofp ∈ (Z/rrk/Z) by the isomorphism of Lemma 8.

Proof. The image of p is the map σ defined by σ(ζrrk) = ζrrpk. Let a ∈ Ar,k, then there are a1, a2, ..., at ∈ Z such that a = Pt

i=1aiζrri k. Now observe that σ(a) = Pt

i=1aiζrrpik ≡ ap (mod p). Since p ∈ q, we have pAr,k ⊂ q and thus σ(a) ≡ ap (mod q). Now assume that a ∈ q, then σ(a) ≡ ap≡ 0 (mod q) and thus σ(a) ∈ q. Now both statements of Definition 22 are satisfied and thus the map Frobqis σ.

(8)

This lemma, the functoriality of the Frobenius element [3] and Lemma 24 give us that for a prime ideal p ⊂ q of Br,k the Frobp corresponds to p ∈ (Z/rrkZ)/∆r.

(9)

5 Computing the residue degree of B

r,k

Using Lemma 23 we can compute the degree f of the residue field with the order of Frobp in Gal(Q(ζrj : k > j ≥ 0)r/Q), which we found to be equal to the order of p in (Z/rrkZ)/∆r. To compute the latter we have the following theorem.

Theorem 26. For l := ordr

pϕ(r)−1 r/r



, the order ofp in (Z/rnZ)/∆r is1 for gcd(r, 2) ≤ n ≤ l and it is rn−l forn ≥ l.

Before we prove this theorem we will first consider two lemmas.

Lemma 27. For n ≥ gcd(r, 2) the map ψ : (Z/rnZ) → (Z/rrn−1Z) defined for every a ∈ Z by a + rnZ 7→ aϕ(r)+ rrn−1Z is a well-defined homomorphism with kernel∆r.

Proof. First let r = 2 and thus r = 4 and n ≥ 2 and thus we have ψ : (Z/2nZ) → (Z/2n+1Z), a + 2nZ 7→ a2+ 2n+1Z. First we will show that ψ is well-defined. Let a, b ∈ Z such that a + 2nZ = b + 2nZ, in other words there is an c ∈ Z such that a = b + c · 2n. Then we have

ψ(a + 2nZ) = a2+ 2n+1aZ + 22nZ = a2+ 2n+1Z

= (b + c · 2n)2+ 2n+1Z

= b2+ c · 2n+1+ c · 22n+ 2n+1Z

= b2+ 2n+1Z = ψ(b + 2nZ) and this shows that ψ is well-defined.

Secondly we will show that ψ is a homomorphism. Clearly ψ(1) = 1. Also for a, b ∈ Z we have

ψ(ab + 2nZ) = (ab + 2nZ)2= (ab)2+ 2n+1abZ + 22nZ = (ab)2+ 2n+1Z, on the other hand we have

ψ(a + 2nZ)ψ(b + 2nZ) = (a + 2nZ)2(b + 2nZ)2

= a2b2+ (a2b2+ ab2)2n+1Z + 22nZ

= (ab)22n+1Z.

Thus ψ(a + 2nZ)ψ(b + 2nZ) = (ab)2+ 2n+1Z = ψ(ab + 2nZ) and thus ψ is a homomorphism in the case r = 2.

Thirdly the kernel of ψ for r = 2 consists of the elements a + 2nZ where a ∈ Z such that a2 ≡ 1 (mod 2n+1). Then also a2 ≡ 1 (mod 2n) and since (Z/2nZ)∼= C2× C2n−2 as mentioned after Lemma 8, we know that the set that consists of all elements with an order in (Z/2nZ) that divides 2 for n = 2 is {±1} ⊂ (Z/2nZ), and for n > 2 is {±1, 2n−1± 1} ⊂ (Z/2nZ). But for the elements 2n−1± 1 we have (2n−1± 1)2≡ 1 ± 2n (mod 2n+1) 6≡ 1 (mod 2n+1).

Thus the kernel is ∆r∼= h−1i ⊂ (Z/2nZ)

Now let r an odd prime number and n ≥ 1. The map ψ : (Z/rnZ) → (Z/rnZ), a mod rn 7→ aϕ(r)mod rn clearly is an endomorphism. The ker- nel consists of the elements a such that ord(a)|r − 1. As mentioned before (Z/rnZ) ∼= Cϕ(r)rn−1, of which the subgroup ∆r consist of all elements of order dividing r − 1, since ∆r has order r − 1 as stated in Lemma 12.

(10)

Corollary 28. The induced homomorphism ψ : (Z/rnZ)/∆r → (Z/rrn−1Z) is injective. Thus for ana ∈ Z\rZ, the order in (Z/rnZ)/∆r of(a + rnZ) mod

r is equal to the order in(Z/rrn−1Z) ofaϕ(r)+ rrn−1Z.

Lemma 29. Let a ∈ Z such that a ≡ 1 mod r, n ≥ 0 and let l0 := ordr(a − 1).

The order of a (mod rn) in (Z/rnZ) is1 for n ≤ l0 andrn−l0 forn ≥ l0. Proof. First we will address the case n ≤ l0. By definition l0 is the greatest power of r that divides a − 1. Thus the order of a (mod rn) in (Z/rnZ) is 1 for n ≤ l0.

Let n > l0 and m ≥ 0. Now let am= arm and lm= ordr(am− 1). Putting x = am− 1 for a given m we find that by the binomium theorem that

(1 + x)r≡ 1 + rx (mod rx2, xr)

≡ 1 + rx (mod rmin(2lm+1,rlm)).

Note that for r = 2 we have l0 ≥ 2 and for r an odd prime integer we have l0≥ 1. Now for m = 0 we have ordr(rx) = lm+ 1 < min(2lm+ 1, rlm) and thus we find that ordr(ar0− 1) = ordr(rx) = l0+ 1. Moreover, we have l1= l0+ 1 and thus for m = 1 we also have ordr(rx) = lm+ 1 < min(2lm+ 1, rlm) and thus ordr(arm− 1) = ordr(rx) = lm+ 1. Now iteratively we find that lm= l0+ m and that l0+ m + 1 = ordr(arm− 1) = ord(arm+1) for m > 0. Thus rn|(an−l0− 1) and rn 6 |(an−l0−1− 1), so the order of a (mod rn) in (Z/rnZ) is rn−l0

Proof. (Theorem 26). Notice for r an odd prime number that Fermat’s little theorem states that for a ∈ Z \ rZ we have ar−1 ≡ 1 (mod r). For r = 2 with a ∈ Z\rZ we have that a2≡ 1 mod 8, since (1+2b)2= 1+4b+4b2= 1+8b(b+1) for b ∈ Z. Thus we can apply Lemma 29 to Corollary 28 for an element a ∈ Z \ rZ. Let l0:= ordr(aϕ(r)− 1), then

ord(Z/rnZ)/∆r(a + rnZ mod ∆r) =

(1 if n + gcd(2, r) − 1 ≤ l0, rn+gcd(2,r)−1−l0 if n + gcd(2, r) − 1 ≥ l0. To simplify we use l := ordr

pϕr−1 r/r

instead of l0:

ord(Z/rnZ)/∆r(a + rnZ mod ∆r) =

(1 if n ≤ l, rn−l if n ≥ l.

Corollary 30. The residue degreef of Br,k is 1 fork ≤ l and is rk−lfork ≥ l.

(11)

6 Prime ideals of B

r

In the last section we determined the residue degree for the rings Br,k. In this section we will determine the number of prime ideals of their union Br. Recall that we defined l := ordr

pϕr−1 r/r



Lemma 31. For k ≥ l the number of prime ideals g of Br,k is equal to the number of prime ideals of Br,l.

Proof. In the previous section we determined the residue degree of Br,k, while in Lemma 24 we determined the ramification index and Corollary 13 gives us the field degree. Now we can calculate with lemma 14 the number of prime ideals g as efn = 1·rrk−lk , which is equal to the number of prime ideals of Br,l. Corollary 32. For every prime ideal pl⊂ Br,land everyk ≥ l the ideal plBr,k

is a prime ideal.

Proof. Lemma 15 gives us that for every prime ideal q ⊂ Br,k there is a unique prime ideal of p ⊂ Br,l such that p = q ∩ Br,l. Note that q divides pBr,l and Lemma 31 gives that the number of prime ideals of Br,k is equal to Br,l, thus q= pBr,l.

Lemma 33. For every prime ideal p ⊂ Br,l the ideal pBR = S

i=lpBr,i is a prime ideal of Br.

Proof. Let a, b ∈ Br and ab ∈ pBr. There is a k > l such that ab ∈ pBr,k and also there is a k0 > k such that a, b ∈ Br,k0. Since pBr,k⊂ pBr,k0 we have that ab ∈ pBr,k0 and since it is prime either a ∈ pBr,k0 or b ∈ pBr,k0. Thus either a ∈ pBr or b ∈ pBr, making pBra prime ideal.

In the introduction we denoted Sp,ras the set of prime ideals of Brcontaining p and it now follows that Sp,r has at least as many prime ideals containing p as Bp,l.

Lemma 34. For p a prime ideal of Br,l the quotientBr/pBr is a field.

Proof. We know that Br,k/pBr,k is a finite field. Because of the primality of pBr the ring Br/pBr is an integral domain, which implies that Br/pBr is a commutative ring. Now we only have to find an inverse for elements of Br/pBr. Let a ∈ Br, then there is an positive integer k such that a ∈ Br,k. There is an element b ∈ Br,k, such that ab ≡ 1 (mod pBr,k). Then b is also in Brand since pBr,k⊂ pBralso ab ≡ 1 ± odpBr. Therefore b is the inverse of a in Br/pBr. Theorem 3. The cardinality of Sp,r is rl and for every prime ideal P ∈Sp,r

there is a unique prime ideal p ofBr,l such that P= p · Br,l.

Proof. Let q ∈ Sp,r, then by Lemma 15 there is a unique prime ideal p of Br,l

such that p = q ∩ Br,l. Likewise for k ≥ l we find pBr,k = q ∩ Br,k, since by Lemma 31 the primes of Br,kand Br,lcorrespond. It follows thatS

i=lpBr,i⊂ q, and then by Lemma 34 it follows that pBr= q.

(12)

7 Finding bases

A0r,k+1

A0r,k B0r,k+1

Br,k0 Xr

Tr

Yr

Figure 1: bases In the previous section we found that

there are rldistinct prime ideals of Br

that contain p and in this section we will make a choice among these prime ideals.

In the quotient Br/p, where p ∈ Sp,r, the elements of Br,l are mapped under the quotient map to an element in Fp. To know where elements of Br,k

are mapped to under the quotient map, we will have to look at the ring gener- ators of Br,k+1over Br,k. The bases of the rings Ar,k and Ar,k+1will help use

find the generators of Br,k. A visual representation is given in Figure 1 which shows the steps we make towards finding the ring generators of Br,k+1.

Before we look at any basis, we will need to add1r to our rings to avoid some problems with the traces for r = 2. The localization should also make our lives easier for any prime r, when we want to find a basis for Ar,k[1r] as a module over Br,k[1r].

Notation. We will denote the ring Br,k[1r], Br[1r], Ar,k[1r] and Ar[1r] as respec- tively B0r,k, Br0, A0r,k and A0r.

Notation. We will write the set of the first n natural numbers {0, 1, 2, ..., n−1}

as Nn.

Consider the sets Xr which we define for r = 2 as the set {1, ζ4} and for r equal to an odd prime number as the set {ζri : i ∈ (Z/rZ)}.

Lemma 35. The setXr is a basis forA0r,i as a module over Br,i0 for all i ≥ 0.

Proof. The set Xris a basis for Ar,0= Z[ζr] over Z thus also for A0r,i over Br,i0 with i = 0. Proposition 6.2(d) from [9] for ζr implies that the discriminant of Ar,0 over Z is a power of r. Thus the greatest common divisor of this dis- criminant and of the discriminant of Br,i over Z is thus also a r power. Now we observe Br,i and Ar,i for i > 0, we know that Br,i· Ar,0 ⊂ Ar,i and thus B0r,i· A0r,0⊂ A0r,i.

Lemma 8 and Corollary 13 tell us that the fields Q[ζr], Q[ζrri]r and Q[ζrri] have respectively degree ϕ(r), ri and ϕ(r)ri over Q and therefore we can apply Lemma 6.5 from [9]. Applying our knowledge about the discriminant we see that for some N ∈ Z>0 the relation Ar,ir1NAr,0· Br,i holds. Since r1N ∈ Z0 it follows that the relation A0r,0·Br,i0 =r1NA0r,0·B0r,iholds and thus A0r,i⊂ A0r,0·Br,i0 . Thus we find that A0r,i = A0r,0· Br,i0 and thus the set Xr is also a basis for A0r,i over B0r,i

Remark. The set {1, ζ4} is not a basis for Z[ζ8] = A2,1 over Z[√

2] = B2,1, since ζ8=

2(1+ζ4)

2 .

Lemma 36. The trace Trr fromA0r,i toBr,i0 is surjective for alli ≥ 0.

(13)

Proof. From Lemma 12 it follows that #∆r = ϕ(r) and thus Trr(Br,i) = ϕ(r) · Br,i. Now for r = 2 we find that Trr(Br,i0 ) = Br,i0 and thus the trace Tr2 from A02,ito B2,i0 is surjective. Now for r an odd prime number, notice that ζr∈ Ar,i and that Trrr) = ζr+ ζr2+ ... + ζrr−1= −1. The image Trr(Ar,i) is an ideal in Br,i and since −1 ∈ Trr(Ar,i) it follows that Trr(Ar,i) = Br,i.

Lemma 37. For odd prime numbers r the natural map ∆r ,→ (Z/rZ) is injective.

Proof. Let α ∈ ∆rsuch that α 6= 1 and notice that αr−1= 1, since by Lemma 12 we have #∆r= r − 1. Note that the zeros in Zrof the polynomial Xr−1− 1 are precisely the elements of ∆r. Note that (X − α)(X − 1)|Xr−1 − 1 and we have the natural map q : Zr → Z/rZ such that for (ai)i≥0 ∈ Zr we have q((ai)i≥0) = a1. Note that if q(α) = 1, then (X − q(α))(X − 1) = (X − 1)2 and then Xr−1− 1 would be inseparable in Fr[X]. We know that Xr−1− 1 is separable in Fr[X], so we have a contradiction and thus q(α) 6= 1.

Let Yr,kfor r = 2 be the set {1, ζrrk+1} and for r 6= 2 be the set {ζrrδk+1: δ ∈

r} ∪ {1}.

Lemma 38. The setYr,k forms a basis forA0r,k+1as an A0r,k-module fork ≥ 0.

Proof. The set {1, ζrri, ζrr2i, ..., ζrrϕ(rri i)−1} is a module basis for Ar,i over Z for all i ≥ 0, as also shown in Theorem 6.4 of [9]. Let a ∈ Ar,k+1, then there are zi∈ Z such that a =P

i∈Nϕ(rrk+1 )ziζrri k+1. Now let yn :=P

j∈Nϕ(rrk )zn+jr·ζrrjk. Then the element a can be written as P

i∈Nryiζrri k+1. Thus for k ≥ 0 the set {ζrri k+1 : i ∈ Nr} is a module basis for Ar,k+1 over Ar,k. Now for r = 2 the lemma holds. Now assume r 6= 2 such that we can apply Lemma 37. Lemma 37 tells us that for every element y of Yr,k there precisely is one element ζ of {ζrri k+1: i ∈ Nr} such that ζ = ζrruky for u ∈ Z. Thus the lemma holds also for r 6= 2.

Lemma 39. Let , δ ∈ ∆r. The element Trrδrrrk)) is equal to the element Trrrrkσ−1δr)).

Proof. The trace of σδrrrk) can be written as the sum of conjugates.

Some manipulations with automorphisms give the identities below.

Trrδrrrk)) = X

u∈∆r

σuδrrrk))

= X

u∈∆r

σuδr))σurrk))

= X

u∈∆r

σrurrk)

Further notice that ∆r is a multiplicative group. Thus multiplying with an ele- ment is an automorphism of ∆r. Thus we can continue with our manipulations

(14)

using v = u.

X

u∈∆r

σrurrk) = X

v∈∆r

σv−1δrvrrk)

= Trr−1δrrrk)

Now we will recall a definition from the introduction, which are the elements in the form of the previous lemma, since ζr= ζrrrrkk−1.

Definition 4. Define the elements ηr,k,i as Trrrr1+irrk k−1).

Lemma 40. The ring Br,k+10 is generated as a module over Br,k0 by the set {ηr,k+1,i+1: i ∈ Nr−1} ∪ {1}.

Proof. For r an odd prime number Lemma 38 gives a module basis for A0r,k+1 over A0r,k, such that for δ = δ (mod rrk) we have the relation

A0r,k+1= M

δ∈∆r

rrδ k+1A0r,k

⊕ A0r,k.

Lemma 35 gives in the same case a module basis for A0r,k over Br,k0 such that for  =  (mod rrk) we have

A0r,k+1= M

δ∈∆r,∈∆r

rr k+1ζrδBr,k0 

⊕ A0r,k.

For r = 2 Lemma 38 gives a module basis for A0r,k+1over A0r,k, and we have the relation

A0r,k+1= A0r,k⊕ ζrrk+1A0r,k.

Furthermore we find a module basis for A0r,k over B0r,k from Lemma 35 such that

A0r,k+1= (Br,k0 ⊕ ζ4Br,k0 ) ⊕ (ζrrk+1Br,k0 ⊕ ζrrk+1ζ4Br,k0 ).

For r equal to an odd prime number we define the sets E, D as ∆rand for r = 2 we will define E, D as {0, 1}.

There are elements bδ,∈ B0r,kand a ∈ A0r,ksuch that an element a ∈ A0r,k+1 can be writen as:

a = a+ X

δ∈D,∈E

bδ,ζrr k+1ζrδ.

Lemma 36 states that for b ∈ B0r,k+1 there is an ab ∈ A0r,k+1 such that b = Trr(ab). Thus there are cδ,∈ Br,k0 , ab∈ A0r,k such that

b = Trr(ab+ X

δ∈D,∈E

cδ,ζrr k+1ζrδ).

From Lemma 39 and the linearity of the trace over Br,k+10 we find that b = Trr(ab) + X

δ∈D,∈E

cδ,Trrrrk+1ζr−1·δ).

(15)

Note that −1r = ∆r for all  ∈ ∆r. Thus for each δ0 ∈ ∆r we can define dδ0 :=P

δ,∈∆r:−1δ=δ0bδ,such that we have b = Trr(a) + X

δ0∈∆r

dδ0ηr,k+1,δ0.

The element Trr(a) is an element of B0r,k since a∈ Ar,k and for all δ0∈ ∆r

is dδ0 an element of Br,k0 , because it is the sums of elements of Br,k0 . Thus every element of B0r,k+1can be written as the sum of products of an element of {ηr,k+1,i+1: i ∈ Nr−1} ∪ {1} times an element of B0r,k.

(16)

8 The Standard Construction

Corollary 30 gives that Br,l0 is mapped into Fpby the natural quotient map of a prime ideal from Sp,r. Theorem 3 tells us that given generators for an ideal of Br,lwe have generators for an ideal in Sp,r. Using a relation between the ideals containing p of Br,l0 and Br,l we can use the ring generators of B0r,l over Z to order Sp,r. We will use use the smallest prime ideal in terms of this ordering to define our standard field of characteristic p and degree rl.

Theorem 5. For P ∈ Sp,r there is a unique system (aP,j)0≤j<lr of integers aP,j ∈ Np such that P is generated as a module over Br by p and {ηr,j+1,i− aP,i+jr: j ∈ Nl, i ∈ Nr}.

Proof. First we will find a set of ring generators for Br,l0 over Z. Lemma 40 tells us that the set {ηr,j+1,i : i ∈ Nr−1}∪{1} generates Br,j+10 as a module over B0r,j. If we take the union of these sets for j < l, then {ηr,j+1,i : i ∈ Nl, j ∈ Nr−1}∪{1}

we find a set of ring generators for Br,l0 over Br,00 = Z.

Given a prime ideal p of Br,l such that p ∈ p, then by Lemma 7.6 of [2]

the localization of the quotient (Br,k/p)[1r] is canonically isomorphic to the quotient Br,k0 /pB0r,k. Note that gcd(p, r) = 1 and thus (Br,k/p)[1r] = (Br,k/p) and Corollary 30 gives then that Br,k0 /pB0r,k∼= Z/pZ. Note that a ring generator of B0r,kis sent to an a ∈ Z/pZ by the quotient map of pBr,k0 . Thus for j ∈ Nlr we can define apBr,j as the element in Npsuch that for j ∈ Nland i ∈ Nrwe have ηr,j+1,i− apBr,i+jr ≡ 0 (mod pBr,l0 ). Then follows that pBr,l0 = (p, ηr,j+1,i− aP,i+jr: j ∈ Nl, i ∈ Nr).

Now we will show that the generating set of p and pB0r,l are equal. In the ring Br,l the ideal (p, ηr,j+1,i − aP,i+jr : j ∈ Nl, i ∈ Nr) ⊂ p has p-power index and after localization we have (p, ηr,j+1,i− aP,i+jr : j ∈ Nl, i ∈ Nr) = p0 and thus the p-power was also an r-power and since gcd(p, r) = 1 we find that(p, ηr,j+1,i− aP,i+jr: j ∈ Nl, i ∈ Nr) = p.

By Theorem 3 are the ideals in Sp,r of the form qBr with q ⊂ Br,l a prime ideal such that p ∈ q, in other words the generating set of q is also the generating set of an ideal in Sp,r.

Now every prime ideal in Sp,r corresponds to a system (ap,j)j∈Nlr of integers ap,j ∈ Np. Thus we can lexicographically order the set of prime ideals by this system.

Definition 6. Define pp,r as the prime ideal such that for a prime ideal q in Sp,r there is a j ∈ Nlr such that for i < j app,r,i= aq,iand app,r,j ≤ aq,j.

The prime ideal pp,r will function as the prime ideal under which we take the quotient.

Theorem 7. Denote the prime ideal pp,r∩ Br,i as pp,r,i and let ηp,j,i = ηp,j,i

(mod pp,r,k). For all k ≥ 0 the field Fpr,l+k,0) has cardinality prk.

Proof. First note that ηr,l,0∈ Fp by Theorem 5 and thus for k = 0 the Lemma follows. For all k > 0 the ring Br,k+l0 is generated as a module over Br,k+10 −1 by the set {ηr,k+l,i+1: i ∈ Nr−1} ∪ {1} and notice that

ηr,j,0= − Trrrrk· −1) = − Trr

ζrrk· X

i∈Nr−1

ζri+1

= − X

i∈Nr−1

ηr,j,i+1.

(17)

Thus we can change the base by removing ηr,k+l,r−1and adding ηr,k+l,0, now we have a relative integral basis for Br,k+lover Br,k+l−1. Furthermore by Corollary 30 we have [Br,l+k/pp,r,l+k: Br,l+k−1/pp,r,l+k−1] = r and thus the set {ηr,k+l,i: i ∈ Nr−1} ∪ {1} is a vector basis for Br,l+k/pp,r,l+k over Br,l+k−1/pp,r,l+k−1.

Since ηr,k+l,0 is an element in a vector basis containing 1, we have that ηr,k+l,0 6∈ Br,l+k−1/pp,r,l+k−1. This means that ηr,k+l,0prk−1 6= ηr,k+l,0, while ηr,k+l,0prk = ηr,k+l,0 that is to say Fpr,k+l,0) has cardinality prk.

So we find that Z/pZ is our field Fp for a prime number p and for rk > 1 a prime power such that gcd(p, r) = 1 we found our standard field Fprk as Fpr,k+l,0).

Note that for fields k, K, L such that K ∼= k[X]/(f (X) and L ∼= k[X]/(g(X)) with irreducible polynomials g, f ∈ k[X] we have an identity for tensor products

K ⊗kL ∼= L[X]/(f (X)).

For a prime number p and positive integer n there are prime numbers r1, r2, ..., rt

and positive numbers a1, a2, ..., at such that n = Qt

i=1raii and for the field F with cardinality pn we can apply this identity to find

F ∼= F1kF2k... ⊗kFt

where Fi is the finite field of cardinality praii for i ∈ {1, 2, ..., t}. Thus in fact have we shown that the algorithm of De Smit and Lenstra constructs correctly the finite fields of cardinality pn where p is a prime number and n an integer such that p - n.

In the construction given by De Smit and Lenstra [4] there is a method such that Fppk for p a prime number and k a positive integer is defined. With this remaining case the tensor product argument shows that the definition of De Smit and Lenstra is correct for Fpn for p a prime number and n any positive integer.

(18)

References

[1] Robert B. Ash. A course in algebraic number theory, 2003. Chapter 8.1.3.

[2] Pete L. Clark. Commutative algebra. http://math.uga.edu/~pete/.

[3] Keith Conrad. Math 676. quadratic characters associated to quadratic fields.

[4] Bart de Smit and Hendrik W. Lenstra. Standard models for finite fields:

the definition.

[5] Bart de Smit and Hendrik W. Lenstra. Standard models for finite fields.

In Gary L Mullen, editor, Handbook of finite fields, Discrete Mathematics and Its Applications. CRC Press, Hoboken, NJ, 2013.

[6] Carl F. Gauss. Disquisitiones arithmeticae. 1801.

[7] Fernando Q. Gouvea. p-adic Numbers: An Introduction. Structure and Bonding. U.S. Government Printing Office, 1997.

[8] Frank L¨ubeck. Conway polynomials for finite fields. http://www.math.

rwth-aachen.de/~Frank.Luebeck/data/ConwayPol/index.html. Re- trieved 2014-7-2.

[9] James S. Milne. Algebraic number theory (v3.06), 2014. Available at www.jmilne.org/math/.

[10] Vreda Pieterse and Paul E. Black. Algorithms and theory of computa- tion handbook, 1999. http://www.nist.gov/dads/HTML/lasVegas.html (retrieved:2014-07-02).

[11] Peter Stevenhagen. Algebra 3, 2012. websites.math.leidenuniv.nl/algebra.

Referenties

GERELATEERDE DOCUMENTEN

This analysis was executed to determine the maximum rotation ( ) and relative angular distortion ( ) which has occurred in the past. The analysis was used to compare the

To find out why a particular media platform like Tinder is more appealing to emerging adults than any other online dating platform, it is important to find out what motivates users to

36 On the other hand, the manifestation part of the freedom- namely the forum externum, the right that individuals have to manifest their religion by, Inter

Les plaques de Herstal, comme celles de Fallais et de Pry, sont pourvues d'un pivot couronné d'une tête animale en ronde bosse.. Cet ornement se trouve déjà sur

Des vases analogues figurent dans des mobiliers de la seconde moitié du Vle siècle par exemple dans la région proche, à Folx-les - Caves, Hollogne-aux-Pierres ainsi

Onderzoek naar de erfgoedwaarden van het sociale woningbouwpatrimonium in Vlaanderen, Onderzoeksrapporten agentschap Onroerend Erfgoed 52, Brussel, 56. 11 Zie ook:

Since the discovery of the CFTR gene in 1989, it has been possible to use gene mutation analysis as an adjunct to sweat testing for the diagnosis of CF.3 The most common

Een methode waarvan de schrijver zich dikwijls en dan met talent bedient, is deze, dat beschouwingen worden gehouden voor twee en drie dimensies (bijvoorbeeld over veelhoeken