A finite element approximation for the quasi-static ... - ANZIAM Journal

8 downloads 1242 Views 530KB Size Report
Dec 24, 2013 - http://www.ctcms.nist.gov/~rdm/mumag.org.html C692 ... mailto:[email protected]. 2. T. Tran ... mailto:[email protected].
ANZIAM J. 54 (CTAC2012) pp.C681–C698, 2013

C681

A finite element approximation for the quasi-static Maxwell–Landau–Lifshitz–Gilbert equations Kim-Ngan Le1

T. Tran2

(Received 31 October 2012; revised 29 July 2013)

Abstract The quasi-static Maxwell–Landau–Lifshitz–Gilbert equations which describe the electromagnetic behaviour of a ferromagnetic material are highly nonlinear. Sophisticated numerical schemes are required to solve the equations, given their nonlinearity and the constraint that the solution stays on a sphere. We propose an implicit finite element solution to the problem. The resulting system of algebraic equations is linear which facilitates the solution process compared to nonlinear methods. We present numerical results to show the efficacy of the proposed method. http://journal.austms.org.au/ojs/index.php/ANZIAMJ/article/view/6318 c Austral. Mathematical Soc. 2013. Published December 24, 2013, as gives this article, part of the Proceedings of the 16th Biennial Computational Techniques and Applications Conference. issn 1446-8735. (Print two pages per sheet of paper.) Copies of this article must not be made otherwise available on the internet; instead link directly to this url for this article.

Contents

C682

Contents 1

Introduction

C682

2

A variational formulation of the MLLG equations

C685

3 The finite element scheme C686 (j) 3.1 A basis for Wh . . . . . . . . . . . . . . . . . . . . . . . . C690 3.2 A basis for Yh . . . . . . . . . . . . . . . . . . . . . . . . . C691 4 Numerical experiments

C692

References

C695

1

Introduction

The Maxwell–Landau–Lifshitz–Gilbert (mllg) equations describe the electromagnetic behaviour of a ferromagnetic material. For simplicity, we assume ˜ ⊂ R3 (with perfectly conducting outer that there is a bounded cavity D ˜ into which a ferromagnet D ⊂ R3 is embeded. We further assume surface ∂D) ˜ D ¯ is a vacuum. Over time period (0, T ) we let DT := (0, T ) × D that D\ ˜ T := (0, T ) × D ˜ , and let S2 be the unit sphere. We denote the unit and D vector of the magnetisation by m(t, x) : DT → S2 , and the magnetic field by ˜ T → R3 over time t and space x. The quasi-static mllg system is H(t, x) : D mt = λ1 m × Heff − λ2 m × (m × Heff ) in DT , ˜T , ˜ t = µ0 Ht + σ∇ × (∇ × H) in D −µ0 m

(1a) (1b)

in which the subscript t indicates a partial derivative with respect to time, λ1 6= 0 , λ2 > 0 , σ > 0 and µ0 > 0 are constants and Heff is the effective ˜ T → R3 is ˜ :D magnetic field which is dependent on both H and m. Here m

1

Introduction

C683

˜ T , that is the zero extension of m onto D  m(t, x) (t, x) ∈ DT , ˜ x) = m(t, ˜ T \DT . 0 (t, x) ∈ D The system (1a)–(1b) is supplemented with initial conditions ˜, m(0, .) = m0 in D and H(0, .) = H0 in D

(2)

and boundary conditions ∂m = 0 on ∂DT ∂n

˜T , and (∇ × H) × n = 0 on ∂D

(3)

where n is the outward normal vector to the relevant surface. Equation (1a) is the first dynamical model for the precessional motion of the magnetisation, suggested by Landau and Lifshitz [8] in 1935. In this model, the time derivative of the magnetisation m is a combination of the precessional movement m×Heff and the dissipative movement m×(m×Heff ) ; see Figure 1. Cimrák [4] showed existence and uniqueness of a local strong solution of (1a)– (3). He also proposed a finite element method to approximate this local solution and provided an error estimation [3]. Baňas, Bartels and Prohl [2] proposed an implicit nonlinear scheme using the finite element method, and proved that the approximate solution converges to a weak global solution. Their method required the condition k = O(h2 ) on the time step k and space step h for the convergence of the nonlinear system of equations resulting from the discretisation. We propose an implicit linear finite element scheme to find a weak global solution to (1a)–(3). This approach was initially developed by Alouges and Jaison [1] for the single Landau–Lifshitz equation (1a). We extend their approach to the system (1a)–(1b). The advantage of this approach is that there is no condition imposed on the time step and the space step. For simplicity we choose the effective field Heff = ∆m + H . We focus on implementation issues of the method. In particular, we show how the

1

Introduction

C684

Figure 1: The combination of the precessional movement m × Heff and the dissipative movement m × (m × Heff ) . finite element spaces and their bases are constructed. In another article we conducted a convergence analysis [9]. In Section 2 we rewrite (1a) in a form which is more suitable for our approach; see (4). We then introduce a variational formulation of the mllg system. Section 3 is devoted to the presentation of the implicit linear finite element scheme. Numerical experiments are presented in the last section.

2

2

A variational formulation of the MLLG equations

C685

A variational formulation of the MLLG equations

Before presenting a variational formulation for the mllg equations, we show how to rewrite (1a) in the form introduced by Gilbert [6] λ1 mt + λ2 m × mt = µm × Heff ,

(4)

in which µ = λ21 + λ22 . Lemma 1. Equation (1a) and equation (4) are equivalent. Proof: By using the elementary identity a × (b × c) = (a · c)b − (a · b)c ,

for all a, b, c ∈ R3 ,

and the property |m| = 1 we obtain m × [m × (m × Heff )] = −m × Heff .

(5)

Assume that m is a solution to (1a). Multiplying both side of (1a) by λ2 m using the vector product and using (5) we obtain λ2 m × mt = λ1 λ2 m × (m × Heff ) + λ22 m × Heff . Multiplying both sides of (1a) by λ1 and adding the resulting equation to the above equation, we deduce that m satisfies (4). Now assume that m is a solution to (4). On multiplying both sides of this equation by λ2 m using the vector product and noting m × (m × mt ) = (m · mt )m − |m|2 mt = −mt , we deduce λ1 λ2 m × mt − λ22 mt = λ2 µm × (m × Heff ) .

(6)

3 The finite element scheme

C686

Subtracting this equation from equation (4) times λ1 and dividing both sides of the resulting equation by µ, we obtain (1a). This proves the lemma. ♠ Before presenting the variational form of this problem, it is necessary to introduce the function spaces

∂u 2 3 1 3 2 3 H (D, R ) = u ∈ L (D, R ) | ∈ L (D, R ) for i = 1, 2, 3 , ∂xi  ˜ = u ∈ L2 (D, ˜ R3 ) | ∇ × u ∈ L2 (D, ˜ R3 ) . H(curl; D) Here L2 (Ω, R3 ) is the usual space of Lebesgue integrable functions defined on Ω and taking values in R3 . Following Lemma 1, instead of solving (1a)–(3) we solve (1b)–(4). A variational form of this problem is as follows. For all φ ∈ C∞ (DT , R3 ) and ζ ∈ ˜ T , R3 ) , find m ∈ H1 (DT ) and H ∈ L2 (D ˜ T ) such that Ht ∈ L2 (D ˜ T ) and C∞ (D ˜ T ) to satisfy the Landau–Lifshitz–Gilbert (llg) equation ∇ × H ∈ L2 (D Z Z λ1 mt · φ dx dt + λ2 (m × mt ) · φ dx dt DT DT Z Z =µ ∇m · ∇(m × φ) dx dt + µ (m × H) · φ dx dt , (7) DT

and Maxwell’s equation Z Z µ0 Ht · ζ dx dt + σ ˜T D

DT

Z ˜T D

∇ × H · ∇ × ζ dx dt = −µ0

˜T D

˜ t · ζ dx dt . (8) m

In the following section we introduce a finite element scheme to approximate the solution (m, H) of (7)–(8).

3

The finite element scheme

˜ into a tetrahedra of Let Th be a regular tetrahedrisation of the domain D maximal mesh size h, and let Th |D be the restriction of Th to the domain D.

3 The finite element scheme

C687

The set of N vertices is Nh := {x1 , . . . , xN } and the set of M edges is Mh := {e1 , . . . , eM } . To discretise the llg equation (7) we introduce the finite element space Vh of all continuous piecewise linear functions on Th |D , which is a subspace of H1 (D, R3 ) . A basis for Vh is chosen to be (φn )16n6N , where φn (xm ) = δn,m , and δn,m is the Kronecker delta. The interpolation operator from C0 (D, R3 ) onto Vh is N X IVh (v) = v(xn )φn for all v ∈ C0 (D, R3 ) . n=1

To discretise Maxwell’s equation (8), we use the space Yh of lowest order edge ˜ . elements of Nedelec’s first family [10] which is a subspace of H(curl; D) For a function u which is Lebesgue integrable on all edges in Mh , we define [10] the interpolation IYh onto Yh as IYh (u) =

M X

˜ R3 ) , for all u ∈ C0 (D,

uq ψq

q=1

Z

where

u · τq ds ,

uq = eq

in which τq is the unit vector in the direction of edge eq . Fixing a positive integer J, we choose the time step k = T/J , and define tj = jk for j = 0, · · · , J . The functions m(tj , ·) and H(tj , ·) are approximated (j) (j) by mh ∈ Vh and Hh ∈ Yh , respectively, for j = 1, 2, . . . , J . Since (j+1)

m(tj+1 , ·) − m(tj , ·) m mt (tj , ·) ≈ ≈ h k

(j)

− mh , k

3 The finite element scheme (j+1)

we evaluate mh

C688

(j)

from mh using (j+1)

mh

(j)

(j)

:= mh + kvh ,

(9)

(j)

where vh is an approximation of mt (tj , ·) . However, to maintain the con(j+1) dition |mh | = 1 , we normalise the right hand side of (9) and therefore (j+1) define mh belonging to Vh by ! N (j) (j) (j) (j) X m + kv m (x ) + kvh (xn ) (j+1) h h h n φn . mh = IVh = (j) (j) (j) (j) |mh + kvh | m (x ) + kv (x ) n=1 n n h h (j)

Hence it suffices to propose a scheme to compute vh . (j)

(j)

Motivated by mt · m = 0 , we find vh in the space Wh defined by

(j) Wh := w ∈ Vh | w(xn ) · mjh (xn ) = 0, n = 1, . . . , N . (j)

(10)

(j)

Given mh ∈ Vh , if (7) is used to compute vh , an approximation to mt (tj , ·) , then a different test space from Vh is required because the test function φ in (7) is not perpendicular to m, unlike mt . To circumvent this difficulty, we use (6) to rewrite (7) as Z Z λ2 mt · w dx dt − λ1 (m × mt ) · w dx dt DT DT Z Z = −µ ∇m · ∇w dx dt + µ H · w dx dt (11) DT

DT

where w = m × φ . Now both mt and w are perpendicular to m for all (j) (j) (t, x) ∈ DT . Hence, given mh ∈ Vh and Hh ∈ Yh , we compute the (j) (j+1) approximations vh and Hh of mt (tj , ·) and H(tj+1 , ·) , respectively, as (j) (j) (j+1) (j) (j) follows. Find vh ∈ Wh and Hh ∈ Yh satisfying, for all wh ∈ Wh and

3 The finite element scheme

C689

ζh ∈ Yh , Z Z (j) (j) (j) (j) (j) λ2 vh · wh dx − λ1 (mh × vh ) · wh dx D Z D Z   (j) (j+1/2) (j) (j) (j) · wh dx dt , = −µ ∇ mh + θkvh · ∇wh dx + µ Hh and

Z µ0

(12)

D

D

Z ˜ D

(j+1) dt Hh

Z

= −µ0

· ξh dx dt + σ

(j+1/2)

˜ D

∇ × Hh

· ∇ × ξh dx dt

(j)

˜ D

vh · ξh dx dt .

(13)

Here, (j+1)

(j+1/2)

Hh

:=

Hh

(j)

+ Hh 2

(j+1)

and dt Hh

(j+1)

:= k−1 (Hh

(j)

− Hh ) .

The parameter θ is arbitrarily chosen to be in [0, 1] . The method is explicit when θ = 0 and fully implicit when θ = 1 . The algorithm for the numerical approximation of the mllg system is summerised in Algorithm 1. By the Lax–Milgram theorem, for each j > 0 there (j) (j) exists a unique solution (vh , Hj+1 h ) ∈ Wh × Yh of equations (12)–(13). Since (0) (j) (j) mh (xn ) = 1 and vh (xn ) · mh (xn ) = 0 for all n = 1, . . . , N , and j = 0, . . . , J , by induction, (j) (j) mh (xn ) + kvh (xn ) > 1

and

(j) mh (xn ) = 1 .

Therefore, the algorithm is well defined. (j)

We now comment on the construction of basis functions for Wh and Yh which are necessary in solving (12)–(13) in Step 5 of Algorithm 1.

3 The finite element scheme

C690

Algorithm 1: Numerical approximation of the mllg system 1 begin 2 Set j = 0 ; 3 Choose m0h = IVh m0 and H0h = IYh H0 ; 4 for j = 0, 1, 2, . . . , J − 1 do (j) (j+1) (j) 5 Solve (12) and (13) to obtain (vh , Hh ) ∈ Wh × Yh ; 6 Define (j+1) mh (x)

7 8

N (j) (j) X mh (xn ) + kvh (xn ) φn (x) ; := (j) (j) n=1 mh (xn ) + kvh (xn )

end end

3.1

(j)

A basis for Wh

(j)

From (10), the basis functions of Wh at each iteration depend on the (j) solution mh computed in the previous iteration. Therefore they must be (j) computed again for each iteration of j in Algorithm 1. For each w ∈ Wh , let αn = w(xn ) n = 1, · · · , N , (1)

(2)

and let αn and αn be two basis vectors of the plane tangential to the vector (j) mh (xn ) = (u1 , u2 , u3 )T ∈ R3 . It follows from (10) that (2) αn = βn α(1) n + γn αn ,

for some real numbers βn and γn . In our computation we take (j)

(j)

(2) (1) α(1) n = Amh (xn ) and αn = mh (xn ) × αn ,

3 The finite element scheme where

C691

  u2 u3 1 1 1 . A =  −1 u2 u3 −1 −2 u2 u3 (j)

A basis for Wh is defined from bases of the 2D planes which are perpendicular (j) (j) to mh (xn ) for all n = 1, . . . , N . Therefore dim(Wh ) = 2N and w is (1) (2) expressed in terms of αn and αn by w(x) =

N X

 (2) βn α(1) φn (x) . n + γn α n

(14)

n=1

It can be shown that

(1) (2) (αn φn , αn φn )

is a basis for the vector

16n6N

(j)

space Wh .

3.2

A basis for Yh

A basis {ψ1 , . . . , ψM } of Yh is defined as follows [10, Section 5.5.1]. Consider an edge eq , q = 1, . . . , M , and let K be the tetrahedron having eq as an edge. (1) (2) Let λq and λq be the barycentric coordinate functions corresponding to the endpoints of eq . We define (2) (2) (1) ψq |K := λ(1) q ∇λq − λq ∇λq .

The relation  (2) ∇ × ψq |K = 2∇λ(1) q × ∇λq ,  is useful in the computation of ∇ × ψq |K .

4 Numerical experiments

4

C692

Numerical experiments

In order to carry out physically relevant experiments, the initial conditions of the mllg equations should be chosen to satisfy the divergence-free constraint [7] ˜ div(H0 + χD m0 ) = 0 in D, where χD is the characteristic function of D. This is achieved by taking H0 = H∗0 − χD m0 ,

(15)

˜ satisfying div H∗ = 0 . In our where H∗0 is some function defined on D 0 experiment, for simplicity, we choose H∗0 to be a constant. We solve the standard problem #4 proposed by the Micromagnetic Modeling Activity Group at the National Institute of Standards and Technology [5]. In this model, the initial conditions m0 and H0 , and the effective field Heff are m0 = (1, 0, 0) in D ,

˜, H∗0 = (0.01, 0.01, 0.01) in D

Heff =

2A ∆m+H . µ∗0 Ms

The parameters

γ γα and λ2 = , 2 1+α 1 + α2 where the positive physical constants are the damping parameter α, the gyromagnetic ratio γ, the vacuum permeability µ∗0 , the exchange constant A, and the magnitude of magnetisation Ms . The values of the physical constants are λ1 = −

α = 1 , σ = 10−13 S−1 m s−1 , µ0 = 2.211739 × 109 H m−1 s−1 , A = 1.3 × 10−11 J m−1 , µ∗0 = 1.25667 × 10−6 H m−1 , γ = 2.2 × 109 m A−1 s−1 , Ms = 8 × 105 A m−1 . ˜ are chosen to be The domains D and D D = (0, 0.5) × (0, 0.125) × (0, 0.003) ,

4 Numerical experiments

C693

0.8 0.6 0.4 0.2 0 −0.2 −0.4 −0.6 −0.8 0.5 0 −0.5

−0.6

−0.4

−0.2

0

0.2

0.4

0.6

0.8

1

1.2

Figure 2: The magnetisation domain D (in red) is a thin film. The magnetic ˜ is in blue. domain D and ˜ = (−0.583, 1.083) × (−0.146, 0.271) × (−0.767, 0.770) , D with distances measured in µm; see Figure 2. The domain D is uniformly partitioned into cubes of dimensions 0.042 × 0.010 × 0.003 µm3 , where each cube consists of six tetrahedra. We generate a nonuniform mesh for the ˜ in such a way that it is identical to the mesh for D in magnetic domain D the region near D, and the mesh size gradually increases away from D. A cross section of the mesh at x3 = 0 is displayed in Figure 3. At each iteration of Algorithm 1, the system to be solved is linear and of

4 Numerical experiments

C694

Table 1: A comparision between Baňas, Bartels and Prohl’s (bbp) method and our method. bbp Our method Discrete system nonlinear linear (uses fixed-point iteration) (solved directly) 3N + M 2N + M Degrees of freedom 2 k = O(h ) None Required condition Basis functions same different of solution space for all iterations in each iteration size 2N + M . A comparision of our method and the method proposed by Baňas, Bartels and Prohl [2] is presented in Table 1. (j)

For j = 0, 1, 2, . . . , let ET be the total energy at time tj = jk defined by Z Z Z 2σA λ2 (j) 2 (j) 2 (j) (j) |∇mh | dx + 2σµ0 |Hh | dx + |∇ × Hh |2 dx ET := Ms D µ D˜ ˜ D (j)

(j)

:= E(j) ex + EH + EE , (j)

(j)

(j)

where Eex , EH and EE are the exchange energy, magnetic field energy and electric field energy, respectively. Our computation shows that the total energy decreases, that is (j+1)

ET

(j)

6 ET

for all j > 0 ;

(16)

(j)

see Figure 4. The decrease of the discrete energy ET , j = 1, . . . , J , suggests the gradient stability of the mllg solutions. In Figure 4 we plot different (j) scaled versions of the different energies versus log t . The change in ET is (j) dominated by the change in EH . (j)

Figure 4 also shows that the sequence {∇mh }j>0 is bounded in L2 (D) , (j) (j) ˜ . In a and the sequences {Hh }j>0 and {∇ × Hh }j>0 are bounded in L2 (D) forthcoming paper, we will show that our numerical solution converges to

References

C695

˜ at x3 = 0 . Figure 3: Mesh for the domain D a weak solution of the problem (1b)–(4) by proving that the inequality (16) holds. Acknowledgements The authors acknowledge financial support through the Australian ARC project DP120101886.

References [1] F. Alouges. A new finite element scheme for Landau–Lifchitz equations. Discrete Contin. Dyn. Syst. Ser. S, 1:187–196 (2008). doi:10.3934/dcdss.2008.1.187 C683 [2] L. Baňas, S. Bartels, and A. Prohl. A convergent implicit finite element discretization of the Maxwell–Landau–Lifshitz–Gilbert equation. SIAM

References

C696

1.4

E energy H Energy 1.2

exchange energy total energy

Energy (J)

1

0.8

0.6

0.4

0.2

0 −2 10

−1

0

10

10

log(t) (ns)

Figure 4: Evolution of the energies, log(t) 7→ EE (t)/600 , EH (t)/106 , 104 Eex (t) , ET (t)/106 .

References

C697

J. Numer. Anal., 46:1399–1422 (2008). doi:10.1137/070683064 C683, C694 [3] I. Cimrák. Error analysis of a numerical scheme for 3D Maxwell–Landau–Lifshitz system. Math. Methods Appl. Sci., 30:1667–1683 (2008). doi:10.1002/mma.863 C683 [4] I. Cimrák. Existence, regularity and local uniqueness of the solutions to the Maxwell–Landau–Lifshitz system in three dimensions. J. Math. Anal. Appl., 329:1080–1093 (2007). doi:10.1016/j.jmaa.2006.06.080 C683 [5] Micromagnetic Modeling Activity Group, Center for Theoretical and Computational Materials Science, National Institute of Standards and Technology, USA. http://www.ctcms.nist.gov/~rdm/mumag.org.html C692 [6] T. L. Gilbert. A Lagrangian formulation of the gyromagnetic equation of the magnetic field. Phys Rev, 100:1243–1255 (1955). Abstract only; full report, Armor Research Foundation Project No. A059, Supplementary Report, May 1, 1956 (unpublished). C685 [7] B. Guo and S. Ding. Landau–Lifshitz Equations, volume 1 of Frontiers of Research with the Chinese Academy of Sciences. World Scientific, Hackensack NJ (2008). doi:10.1142/9789812778765 C692 [8] L. Landau and E. Lifschitz. On the theory of the dispersion of magnetic permeability in ferromagnetic bodies. Phys Z Sowjetunion, 8:153–168 (1935); Perspectives in Theoretical Physics, pp. 51–65, Pergamon, Amsterdam (1992). doi:10.1016/B978-0-08-036364-6.50008-9 C683 [9] K.-N. Le and T. Tran. A convergent finite element approximation for the quasi-static Maxwell–Landau–Lifshitz–Gilbert equations. Research Report, arXiv:1212.3369, 2012, submitted to Computers & Mathematics with Applications. http://arxiv.org/abs/1212.3369 C684

References

C698

[10] P. Monk. Finite Element Methods for Maxwell’s equations. Numerical Mathematics and Scientific Computation. Oxford University Press, New York (2003). C687, C691

Author addresses 1. Kim-Ngan Le, School of Mathematics and Statistics, The University of New South Wales, Sydney 2052, Australia. mailto:[email protected] 2. T. Tran, School of Mathematics and Statistics, The University of New South Wales, Sydney 2052, Australia. mailto:[email protected]

Suggest Documents