Next Article in Journal
Efficiency of Various Tiling Strategies for the Zuker Algorithm Optimization
Previous Article in Journal
Persistent Homology Identifies Pathways Associated with Hepatocellular Carcinoma from Peripheral Blood Samples
 
 
Font Type:
Arial Georgia Verdana
Font Size:
Aa Aa Aa
Line Spacing:
Column Width:
Background:
Article

A Two-Grid Algorithm of the Finite Element Method for the Two-Dimensional Time-Dependent Schrödinger Equation

1
School of Science, Hunan University of Technology, Zhuzhou 412007, China
2
School of Mathematics and Computational Science, Hunan University of Science and Technology, Xiangtan 411201, China
3
School of Computational Science and Electronics, Hunan Institute of Engineering, Xiangtan 411104, China
4
College of Information and Intelligence, Hunan Agricultural University, Changsha 410128, China
*
Authors to whom correspondence should be addressed.
Mathematics 2024, 12(5), 726; https://doi.org/10.3390/math12050726
Submission received: 22 January 2024 / Revised: 23 February 2024 / Accepted: 23 February 2024 / Published: 29 February 2024
(This article belongs to the Section Computational and Applied Mathematics)

Abstract

:
In this paper, we construct a new two-grid algorithm of the finite element method for the Schrödinger equation in backward Euler and Crank–Nicolson fully discrete schemes. On the coarser grid, we solve coupled real and imaginary parts of the Schrödinger equation. On the fine grid, real and imaginary parts of the Schrödinger equation are decoupled, and we solve the elliptic equation about real and imaginary parts, respectively. Then, we obtain error estimates of the exact solution with the two-grid solution in the H 1 -norm and carry out two numerical experiments.

1. Introduction

In this paper, we consider the initial boundary value problem of the following linear Schrödinger equation:
i u t ( x , t ) = Δ u ( x , t ) + V ( x ) u ( x , t ) + f ( x , t ) , ( x , t ) Ω × ( 0 , T ] , u ( x , t ) = 0 , ( x , t ) Ω × ( 0 , T ] , u ( x , 0 ) = u 0 ( x ) , x Ω ,
where Δ is the usual Laplace operator, i = 1 is the complex unit, and Ω R 2 is a convex polygonal domain with smooth boundary Ω . The functions u ( x , t ) , u 0 ( x ) , and f ( x , t ) are complex-valued, and the trapping potential function V ( x ) is real-valued and non-negative bounded.
The Schrödinger equation is the most fundamental equation in quantum mechanics. There are many pieces of research solving the Schrödinger equation using the finite element method  [1,2,3,4,5]. The two-grid method was proposed by Xu [6,7] as a discretization method for nonsymmetric, indefinite, and nonlinear partial differential equations. The two-grid method has been applied to elliptic problems [8,9,10], parabolic equations [11,12,13,14], reaction–diffusion equations [15,16], displacement problems [17,18], and Maxwell equations [19,20]. Jin et al. [21] first proposed a two-grid finite element method for solving the Schrödinger-type equation. Chien et al. [22] studied efficient two-grid discretization schemes with two-loop continuation algorithms for computing the nonlinear Schrödinger equation. Wu [23] and Hu [24] constructed two-grid mixed finite element schemes for solving the nonlinear Schrödinger equation. Tian et al. [25,26] studied the two-grid finite element method for solving the linear Schrödinger equation.
In this paper, we improve the two-grid algorithm in [25,26] for the Schrödinger equation (Equation (1)). We obtain the fully discrete finite element scheme by backward Euler and Crank–Nicolson methods in time and construct a new two-grid algorithm in two fully discrete schemes. With this algorithm, we solve the original coupled equation on a much coarser grid with size H > > h and solve the decoupled equation on the fine grid. On the fine grid, we solve the elliptic equation about real and imaginary parts, and two Poisson equations are solved on the fine grid found in [25,26]. In addition, the two-grid solutions are more accurate than those in [25,26].
This paper is organized as follows. We provide some notations in Section 2. In Section 3, we construct a two-grid algorithm in the backward Euler scheme. In Section 4, we provide the two-grid algorithm in the Crank–Nicolson scheme. In Section 5, two numerical examples are carried out to confirm the theoretical analysis. The symbol C is used for a positive constant that is independent of temporal size τ and spatial sizes h and H.

2. Notation and Preliminaries

We use W m , p to denote the standard Sobolev space of complex-valued measurable functions, defined on Ω with the norm ϕ m , p p = | α | m D α ϕ L p ( Ω ) p . To simplify the notation, we also use the symbol H m for W m , 2 , · m instead of · m , 2 and · instead of · 0 , 2 .
For any two complex-valued functions u ( x ) , v ( x ) L 2 ( Ω ) , the inner product ( u , v ) is defined by
( u , v ) = Ω u ( x ) v ¯ ( x ) d x ,
where v ¯ ( x ) denotes the complex conjugate of v ( x ) .
The weak solution u ( x , t ) of Problem (1) can be defined as follows: find u ( x , t ) H 0 1 ( Ω ) , t [ 0 , T ] such that
i ( u t , v ) = a ( u , v ) + ( f , v ) , v H 0 1 ( Ω ) , u ( x , 0 ) = u 0 ( x ) ,
where
a ( u , v ) = ( u , v ) + ( V u , v ) .
Let Γ h be the quasi-uniform triangular or rectangular partition of the domain Ω with the mesh size 0 < h < 1 and S h H 0 1 ( Ω ) be the corresponding linear finite element space on Γ h . In general, given a function w ( x , t ) H 0 1 ( Ω ) , we define its elliptic projection P h w ( x , t ) S h such that
a ( P h w , v h ) = a ( w , v h ) , v h S h .
Lemma 1
([5]). If, for any t [ 0 , T ] , u ( x , t ) , u t ( x , t ) H 2 ( Ω ) , then the elliptic projection P h u ( x , t ) S h has the following error estimates:
u P h u s C h 2 s u 2 , s = 0 , 1 ,
( u P h u ) t s C h 2 s u t 2 , s = 0 , 1 .

3. Two-Grid Algorithm in the Backward Euler Fully Discrete Scheme

Let τ = T N be the time step, N be a positive integer, and t j = j τ and I j = [ t j 1 , t j ] ,   j = 1 , 2 , , N be the time nodes and time elements, respectively. We also use the symbol w j for any function w ( x , t j ) , and, for function series w j ( x ) , j = 0 , 1 , , N , let
t w j = 1 τ ( w j ( x ) w j 1 ( x ) ) .
We define the backward Euler fully discrete finite element solution u h n ( x ) S h ,   n = 0 , 1 , , N , to Problem (1) as satisfying
i ( t u h n , v h ) = a ( u h n , v h ) + ( f n , v h ) , v h S h , u h 0 ( x ) = P h u 0 ( x ) .
Lemma 2
([25]). Let u ( x , t ) be the solution defined in (2), function series u h n ( x ) be the fully discrete finite element solution defined in (6), and η n = u h n P h u n ; then,
u h n P h u n C τ + C h 2 ,
η n η n 1 C τ ( τ + h 2 ) .
Let the finite element space S H S h be defined on a coarser quasi-uniform partition of Ω with mesh size H < h . Then, we construct a new two-grid algorithm in the backward Euler fully discrete scheme for Equation (2), Algorithm 1.
Algorithm 1: Two-grid finite element in the backword Euler scheme.
Step 1: Find the fully discrete finite element solutions { u H n ( x ) } n = 1 N S H such that
i ( t u H n , v H ) = a ( u H n , v H ) + ( f n , v H ) , v H S H , u H 0 ( x ) = P H u 0 ( x ) .
Step 2: Find { u ˜ h n ( x ) } n = 1 N S h such that
( u ˜ h n , v h ) + ( V u ˜ h n , v h ) = i ( t u H n , v h ) ( f n , v h ) , v h S h , u ˜ h 0 ( x ) = P h u 0 ( x ) .
Theorem 1.
Let u ( x , t ) be the solution defined in (2), and u ˜ h n ( x , t ) be the two-grid finite element solution defined in (10); then, we have
u ˜ h n P h u n 1 C τ + C h 2 + C H 2 ,
u n u ˜ h n 1 C τ + C h + C H 2 .
Proof. 
It follows from (2) that
( u n , v h ) + ( V u n , v h ) = i ( u t n , v h ) + ( f n , v h ) ,
and, from (10) and (13), we have
( ( u n u ˜ h n ) , v h ) + ( V ( u n u ˜ h n ) , v h ) = i ( u t n t u H n , v h ) .
Let u n u ˜ h n = ρ n ξ n , with
ρ n = u n P h u n , ξ n = u ˜ h n P h u n ;
it follows from (3) and (15) that
a ( ρ n , v h ) = 0 .
From (16), (14) and (15), we can see that
( ξ n , v h ) + ( V ξ n , v h ) = i ( t u H n t P h u n , v h ) i ( t ρ n , v h ) i ( u t n t u n , v h ) .
Taking v h = ξ n in (17), we have
( ξ n , ξ n h ) + ( V ξ n , ξ n ) = i ( t u H n t P h u n , ξ n ) i ( t ρ n , ξ n ) i ( u t n t u n , ξ n ) ;
thus,
ξ n 2 +   V 0 ξ n 2   | ( t u H n t P h u n , ξ n ) |   +   | ( t ρ n , ξ n ) |   +   | ( u t n t u n , ξ n ) | ( t u H n t P h u n   +   t ρ n   +   u t n t u n ) ξ n .
By using the Cauchy inequality, we have
ξ n 2 +   C ξ n 2     t u H n t P h u n 2 +   t ρ n 2 +   u t n t u n 2 .
It follows from (8) that
t ( u h n P h u n )   C τ + C h 2 ,
and combining with (5) gives
t ( u n P h u n ) = τ 1 t n 1 t n ( u P h u ) t d t τ 1 t n 1 t n ( u P h u ) t d t C h 2 .
From (21) and (22), we have
t ( u n u h n )     t ( u h n P h u n )   +   t ( u n P h u n )   C τ + C h 2 ,
which implies that
t ( u n u H n )   C τ + C H 2 .
From (21), (23) and (24), we have
t u H n t P h u n   t ( u h n P h u n )   +   t ( u n u h n )   +   t ( u n u H n ) C τ + C h 2 + C H 2 .
Combining with (4) yields
t ρ n = τ 1 ( u n u n 1 ) P h ( u n u n 1 ) C τ 1 h 2 u n u n 1 2 = C τ 1 h 2 t n 1 t n u t ( · , t ) d t 2 C τ 1 h 2 t n 1 t n u t ( · , t ) 2 d t C h 2 .
In addition,
u t n t u n 2 =   τ 1 t n 1 t n ( t t n 1 ) u t t ( · , t ) d t 2 = τ 2 Ω t n 1 t n ( t t n 1 ) u t t ( · , t ) d t 2 d Ω τ 2 Ω t n 1 t n ( t t n 1 ) 2 d t t n 1 t n u t t 2 ( · , t ) d t d Ω C τ Ω t n 1 t n u t t 2 ( · , t ) d t d Ω = C τ t n 1 t n u t t ( · , t ) 2 d t C τ 2 .
From (20) and (25)–(27), we have
ξ n 2 +   C ξ n 2 C τ 2 + C h 4 + C H 4 ;
thus,
ξ n 1     C τ + C h 2 + C H 2 .
Therefore, the proof of (11) is complete, and (12) follows from (4) and (11).    □

4. Two-Grid Algorithm in the Crank–Nicolson Fully Discrete Scheme

For function series w j ( x ) , j = 0 , 1 , , let
t w j + 1 2 = 1 τ ( w j + 1 ( x ) w j ( x ) ) , w j + 1 2 = 1 2 ( w j + 1 ( x ) + w j ( x ) ) .
Then, the Crank–Nicolson fully discrete finite element solution u h n ( x ) S h , n = 0 , 1 , , N , to Problem (1) can be defined by
i ( t u h n + 1 2 , v h ) = a ( u h n + 1 2 , v h ) + ( f n + 1 2 , v h ) , v h S h , u h 0 ( x ) = P h u 0 ( x ) .
Lemma 3
([26]). Let u ( x , t ) be the solution defined in (2), function series u h n ( x ) be the fully discrete finite element solution defined in (30), and η n = u h n P h u n ; then,
u h n P h u n   C τ 2 + C h 2 ,
η n η n 1   C τ ( τ 2 + h 2 ) .
Next, we present the two-grid algorithm in the Crank–Nicolson fully discrete scheme for Equation (2), Algorithm 2.
Algorithm 2: Two-grid finite element in the Crank–Nicolson scheme.
Step 1: Find the fully discrete finite element solutions { u H n ( x ) } n = 1 N S H such that
i ( t u H n + 1 2 , v H ) = a ( u H n + 1 2 , v H ) + ( f n + 1 2 , v H ) , v H S H , u H 0 ( x ) = P H u 0 ( x ) .
Step 2: Find { u ^ h n ( x ) } n = 1 N S h such that
( u ^ h n + 1 2 , v h ) + ( V u ^ h n + 1 2 , v h ) = i ( t u H n + 1 2 , v h ) ( f n + 1 2 , v h ) , v h S h , u ^ h 0 ( x ) = P h u 0 ( x ) .
Theorem 2.
Let u ( x , t ) be the solution defined in (2) and u ^ h n ( x , t ) be the two-grid finite element solution defined in (34); then, we have
u ^ h n P h u n 1   C τ 2 + C h 2 + C H 2 ,
u n u ^ h n 1   C τ 2 + C h + C H 2 .
Proof. 
It follows from (2) that
( u n + 1 2 , v h ) + ( V u n + 1 2 , v h ) = i ( u t n + 1 2 , v h ) + ( f n + 1 2 , v h ) ,
and, from (34) and (37), we have
( ( u n + 1 2 u ^ h n + 1 2 ) , v h ) + ( V ( u n + 1 2 u ^ h n + 1 2 ) , v h ) = i ( u t n + 1 2 t u H n + 1 2 , v h ) .
Let u n u ^ h n = ρ n θ n , with
ρ n = u n P h u n , θ n = u ^ h n P h u n ;
combining (16) with (38) and (39) gives
( θ n + 1 2 , v h ) + ( V θ n + 1 2 , v h ) = i ( t u H n + 1 2 t P h u n + 1 2 , v h ) i ( t ρ n + 1 2 , v h ) i ( u t n + 1 2 t u n + 1 2 , v h ) .
Taking v h = θ n + 1 2 in (40), we have
( θ n + 1 2 , θ n + 1 2 ) + ( V θ n + 1 2 , θ n + 1 2 ) = i ( t u H n + 1 2 t P h u n + 1 2 , θ n + 1 2 ) i ( t ρ n + 1 2 , θ n + 1 2 ) i ( u t n + 1 2 t u n + 1 2 , θ n + 1 2 ) ;
thus,
θ n + 1 2 2 +   V 0 θ n + 1 2 2   | ( t u H n + 1 2 t P h u n + 1 2 , θ n + 1 2 ) |   +   | ( t ρ n + 1 2 , θ n + 1 2 ) | +   | ( u t n + 1 2 t u n + 1 2 , θ n + 1 2 ) | ( t u H n + 1 2 t P h u n + 1 2 + t ρ n + 1 2 +   u t n + 1 2 t u n + 1 2 ) θ n + 1 2 .
By using the Cauchy inequality, we have
θ n + 1 2 2 +   C θ n + 1 2 2   t u H n + 1 2 t P h u n + 1 2 2 +   t ρ n + 1 2 2 +   u t n + 1 2 t u n + 1 2 2 .
It follows from (32) that
t ( u h n + 1 2 P h u n + 1 2 )   C τ 2 + C h 2 ,
and, from (22) and (44), we have
t ( u n + 1 2 u h n + 1 2 )   t ( u h n + 1 2 P h u n + 1 2 )   +   t ( u n + 1 2 P h u n + 1 2 ) C τ 2 + C h 2 ,
which implies that
t ( u n + 1 2 u H n + 1 2 )   C τ 2 + C H 2 .
From (44)–(46), we have
t u H n + 1 2 t P h u n + 1 2   t ( u h n + 1 2 P h u n + 1 2 )   +   t ( u n + 1 2 u h n + 1 2 ) +   t ( u n + 1 2 u H n + 1 2 ) C τ 2 + C h 2 + C H 2 .
Combining with (4) yields
t ρ n + 1 2 = τ 1 ( u n + 1 u n ) P h ( u n + 1 u n ) C τ 1 h 2 u n + 1 u n 2 = C τ 1 h 2 t n t n + 1 u t ( · , t ) d t 2 C τ 1 h 2 t n t n + 1 u t ( · , t ) 2 d t C h 2 .
In addition,
u t n + 1 2 t u n + 1 2 = 1 2 τ t n t n + 1 2 ( t t n ) 2 u t t t ( · , t ) d t + t n + 1 2 t n + 1 ( t t n + 1 ) 2 u t t t ( · , t ) d t 1 2 τ t n t n + 1 2 τ 2 2 u t t t ( · , t ) d t + t n + 1 2 t n + 1 τ 2 2 u t t t ( · , t ) d t = τ 8 t n t n + 1 u t t t ( · , t ) d t τ 8 t n t n + 1 u t t t ( · , t ) d t C τ 2 .
From (43) and (47)–(49), we have
θ n + 1 2 2 +   C θ n + 1 2 2 C ( τ 2 + h 2 + H 2 ) 2 ;
thus,
θ n + 1 2 1     C τ 2 + C h 2 + C H 2 .
Similar to the derivation in [26], we have
θ n 1   C ( τ 2 + h 2 + H 2 ) .
Therefore, (35) follows from (52) and (36) follows from (4) and (35). □

5. Numerical Examples

All simulations were carried out using MATLAB R2011a on a Windows server with Intel Core i5-8265 processor that possessed 8 GB RAM and a 1.60 GHz CPU.
Example 1
([25]). We consider the following linear Schrödinger equation:
i u t ( x , t ) = Δ u ( x , t ) + u ( x , t ) + f ( x , t ) , ( x , t ) Ω × ( 0 , 1 ] , u ( x , t ) = 0 , ( x , t ) Ω × ( 0 , 1 ] , u ( x , 0 ) = u 0 ( x ) , x Ω ,
where Ω = [ 1 , 1 ] × [ 1 , 1 ] and the function f ( x , t ) is chosen corresponding to the exact solution
u ( x , y , t ) = 2 t 4 ( 1 x 2 ) ( 1 y 2 ) + i e t sin ( π ( 1 + x ) ) sin ( π ( 1 + y ) ) .
Let Γ H and Γ h be the quasi-uniform triangular partition of Ω with mesh sizes satisfying h = H 2 . The linear finite element solution u h n is computed by the back Euler fully discrete scheme, the two-grid solution u ˜ h n is computed by Algorithm 1, and U h n is the two-grid solution in [25]. The errors and CPU costs with respect to different times are listed in Table 1, Table 2, Table 3 and Table 4. We can see that the two-grid solution can achieve the same accuracy as the finite element solution and the two-grid method can save many CPU costs. In addition, the errors in the two-grid solution are less than those in [25]. The profiles of three solutions at t = 1.0 on a 32 × 32 mesh are plotted in Figure 1, Figure 2 and Figure 3.
Example 2
([26]). The function f ( x , t ) in Equation (53) is chosen corresponding to the exact solution
u ( x , y , t ) = ( 1 + i ) e t ( 1 + x ) ( 1 + y ) sin ( 1 x ) sin ( 1 y ) .
The domain Ω is uniformly divided into families Γ H and Γ h of rectangular meshes with h = H 2 . The bilinear finite element solution u h n is computed by the Crank–Nicolson fully discrete scheme, the two-grid solution u ^ h n is computed by Algorithm 2, and U h n is the two-grid solution in [26]. The errors and CPU costs with respect to different times are listed in Table 5, Table 6, Table 7 and Table 8. It is obvious that errors in the two-grid solution are less than those in [26]. The profiles of three solutions at t = 1.0 on a 32 × 32 mesh are plotted in Figure 4, Figure 5 and Figure 6.

6. Conclusions

In this paper, we have constructed a new two-grid algorithm in two fully discrete finite element schemes for the linear Schrödinger equation and have obtained error estimates of the exact solution with the two-grid solution. In the future, we will consider the two-grid algorithm of the finite element method for the nonlinear Schrödinger equation.

Author Contributions

Methodology, J.W., Z.T. and Y.L.; Formal analysis, J.W., Z.T. and Y.L.; Data curation, Z.Z.; Writing —original draft, J.W.; Writing—review & editing, J.W. and Z.T.; Visualization, Z.Z. All authors have read and agreed to the published version of the manuscript.

Funding

This work was supported by the National Natural Science Foundation of China (No. 12101224).

Data Availability Statement

No data were used to support this study.

Conflicts of Interest

The authors declare no conflicts of interest.

References

  1. Akrivis, G.D.; Dougalis, V.A.; Karakashian, O.A. On fully discrete Galerkin methods of second-order temporal accuracy for the nonlinear Schrödinger equation. Numer. Math. 1991, 59, 31–53. [Google Scholar] [CrossRef]
  2. Antonopoulou, D.C.; Karali, G.D.; Plexousakis, M.; Zouraris, G.E. Crank-Nicolson finite element discretizations for a two-dimensional linear Schrödinger-type equation posed in a noncylindrical domain. Math. Comp. 2015, 84, 1571–1598. [Google Scholar] [CrossRef]
  3. Li, M.; Gu, X.; Huang, C.; Fei, M.; Zhang, G. A fast linearized conservative finite element method for the strongly coupled nonlinear fractional Schrödinger equations. J. Comput. Phys. 2018, 358, 256–282. [Google Scholar] [CrossRef]
  4. Shi, D.; Wang, P.; Zhao, Y. Superconvergence analysis of anisotropic linear triangular finite element for nonlinear Schrödinger equation. Appl. Math. Lett. 2014, 38, 129–134. [Google Scholar] [CrossRef]
  5. Tian, Z.; Chen, Y.; Wang, J. Superconvergence analysis of bilinear finite element for the nonlinear Schrödinger equation on the rectangular mesh. Adv. Appl. Math. Mech. 2018, 10, 468–484. [Google Scholar] [CrossRef]
  6. Xu, J. A novel two-grid method for semilinear equations. SIAM J. Sci. Comput. 1994, 15, 231–237. [Google Scholar] [CrossRef]
  7. Xu, J. Two-grid discretization techniques for linear and nonlinear PDE. SIAM J. Numer. Anal. 1996, 33, 1759–1777. [Google Scholar] [CrossRef]
  8. Huang, Y.; Chen, Y. A multi-level iterative method for solving finite element equations of nonlinear singular two-point boundary value problems. Nat. Sci. J. Xiangtan Univ. 1994, 16, 23–26. (In Chinese) [Google Scholar]
  9. Xu, J.; Zhou, A. Local and parallel finite element algorithms based on two-grid discretizations. Math. Comp. 2000, 69, 881–909. [Google Scholar] [CrossRef]
  10. Bi, C.; Wang, C.; Lin, Y. A posteriori error estimates of two-grid finite element methods for nonlinear elliptic problems. J. Sci. Comput. 2018, 74, 23–48. [Google Scholar] [CrossRef]
  11. Dawson, C.N.; Wheeler, M.F. Two-grid method for mixed finite element approximations of non-linear parabolic equations. Contemp. Math. 1994, 180, 191–203. [Google Scholar]
  12. Chen, Y.; Luan, P.; Lu, Z. Analysis of two-grid methods for nonlinear parabolic equations by expanded mixed finite element methods. Adv. Appl. Math. Mech. 2009, 1, 830–844. [Google Scholar] [CrossRef]
  13. Chen, C.; Yang, M.; Bi, C. Two-grid methods for finite volume element approximations of nonlinear parabolic equations. J. Comput. Appl. Math. 2009, 228, 123–132. [Google Scholar] [CrossRef]
  14. Shi, D.; Yang, H. Unconditional optimal error estimates of a two-grid method for semilinear parabolic equation. Appl. Math. Comput. 2017, 310, 40–47. [Google Scholar] [CrossRef]
  15. Chen, L.; Chen, Y. Two-grid method for nonlinear reaction-diffusion equations by mixed finite element methods. J. Sci. Comput. 2011, 49, 383–401. [Google Scholar] [CrossRef]
  16. Chen, Y.; Huang, Y.; Yu, D. A two-grid method for expanded mixed finite-element solution of semilinear reaction-diffusion equations. Int. J. Numer. Meth. Eng. 2003, 57, 193–209. [Google Scholar] [CrossRef]
  17. Chen, Y.; Hu, H. Two-grid method for miscible displacement problem by mixed finite element methods and mixed finite element method of characteristics. Commun. Comput. Phys. 2016, 19, 1503–1528. [Google Scholar] [CrossRef]
  18. Chen, Y.; Zeng, J.; Zhou, J. Lp error estimates of two-grid method for miscible displacement problem. J. Sci. Comput. 2016, 69, 28–51. [Google Scholar] [CrossRef]
  19. Zhong, L.; Liu, C.; Shu, S. Two-level additive preconditioners for edge element discretizations of time-harmonic Maxwell equations. Comput. Math. Appl. 2013, 66, 432–440. [Google Scholar] [CrossRef]
  20. Zhou, J.; Hu, X.; Zhong, L.; Shu, S.; Chen, L. Two-grid methods for Maxwell eigenvalue problems. SIAM J. Numer. Anal. 2014, 52, 2027–2047. [Google Scholar] [CrossRef]
  21. Jin, J.; Shu, S.; Xu, J. A two-grid discretization method for decoupling systems of partial differential equations. Math. Comp. 2006, 75, 1617–1626. [Google Scholar] [CrossRef]
  22. Chien, C.S.; Huang, H.T.; Jeng, B.W.; Li, Z.C. Two-grid discretization schemes for nonlinear Schrödinger equations. J. Comput. Appl. Math. 2008, 214, 549–571. [Google Scholar] [CrossRef]
  23. Wu, L. Two-grid mixed finite-element methods for nonlinear Schrödinger equations. Numer. Methods Partial. Differ. Equ. 2012, 28, 63–73. [Google Scholar] [CrossRef]
  24. Hu, H. Two-grid method for two-dimensional nonlinear Schrödinger equation by mixed finite element method. Comput. Math. Appl. 2018, 75, 900–917. [Google Scholar] [CrossRef]
  25. Tian, Z.; Chen, Y.; Huang, Y.; Wang, J. Two-grid method for the two-dimensional time-dependent Schrödinger equation by the finite element method. Comput. Math. Appl. 2019, 77, 3043–3053. [Google Scholar] [CrossRef]
  26. Wang, J.; Jin, J.; Tian, Z. Two-grid finite element method with Crank-Nicolson fully discrete scheme for the time-dependent Schrödinger equation. Numer. Math. Theor. Meth. Appl. 2020, 13, 334–352. [Google Scholar]
Figure 1. The exact solution in the backward Euler scheme.
Figure 1. The exact solution in the backward Euler scheme.
Mathematics 12 00726 g001
Figure 2. The finite element solution in the backward Euler scheme.
Figure 2. The finite element solution in the backward Euler scheme.
Mathematics 12 00726 g002
Figure 3. The two-grid solution in the backward Euler scheme.
Figure 3. The two-grid solution in the backward Euler scheme.
Mathematics 12 00726 g003
Figure 4. The exact solution in the Crank–Nicolson scheme.
Figure 4. The exact solution in the Crank–Nicolson scheme.
Mathematics 12 00726 g004
Figure 5. The finite element solution in the Crank–Nicolson scheme.
Figure 5. The finite element solution in the Crank–Nicolson scheme.
Mathematics 12 00726 g005
Figure 6. The two-grid solution in the Crank–Nicolson scheme.
Figure 6. The two-grid solution in the Crank–Nicolson scheme.
Mathematics 12 00726 g006
Table 1. The error and CPU cost at t = 0.1 in the backward Euler scheme.
Table 1. The error and CPU cost at t = 0.1 in the backward Euler scheme.
H u n u h n 1 OrderTime (s) u n u ˜ h n 1 OrderTime (s) u n U h n 1
1 / 4 4.8118 × 10 1 /1.015.5043× 10 1 /0.0225.6914 × 10 1
1 / 8 1.2050 × 10 1 1.0026.21.3769 × 10 1 1.000.2271.4358 × 10 1
1 / 16 3.0129 × 10 2 1.007193.4431 × 10 2 1.005.133.5989 × 10 2
Table 2. The error and CPU cost t = 0.2 in the backward Euler scheme.
Table 2. The error and CPU cost t = 0.2 in the backward Euler scheme.
H u n u h n 1 OrderTime (s) u n u ˜ h n 1 OrderTime (s) u n U h n 1
1 / 4 5.3163 × 10 1 /1.815.8987 × 10 1 /0.0235.8826 × 10 1
1 / 8 1.3317 × 10 1 1.0053.51.4885 × 10 1 0.990.2351.4925 × 10 1
1 / 16 3.3300 × 10 2 1.0013373.7389 × 10 2 1.005.213.7566 × 10 2
Table 3. The error and CPU cost at t = 0.5 in the backward Euler scheme.
Table 3. The error and CPU cost at t = 0.5 in the backward Euler scheme.
H u n u h n 1 OrderTime (s) u n u ˜ h n 1 OrderTime (s) u n U h n 1
1 / 4 7.1758 × 10 1 /4.487.5505 × 10 1 /0.0247.8295 × 10 1
1 / 8 1.7980 × 10 1 1.001281.8546 × 10 1 1.010.2411.9261 × 10 1
1 / 16 4.4970 × 10 2 1.0037694.6007 × 10 2 1.015.384.7613 × 10 2
Table 4. The error and CPU cost at t = 1.0 in the backward Euler scheme.
Table 4. The error and CPU cost at t = 1.0 in the backward Euler scheme.
H u n u h n 1 OrderTime (s) u n u ˜ h n 1 OrderTime (s) u n U h n 1
1 / 4 1.2075 × 10 0 /8.881.2310 × 10 0 /0.0281.2626 × 10 0
1 / 8 3.0266 × 10 1 1.002533.0539 × 10 1 1.010.2433.1258 × 10 1
1 / 16 7.6032 × 10 2 1.0075517.6687 × 10 2 1.005.567.8453 × 10 2
Table 5. The error and CPU cost at t = 0.1 in the Crank–Nicolson scheme.
Table 5. The error and CPU cost at t = 0.1 in the Crank–Nicolson scheme.
H u n u h n 1 OrderTime (s) u n u ^ h n 1 OrderTime (s) u n U h n 1
1 / 4 8.6473 × 10 2 /1.558.9016 × 10 2 /1.238.9119 × 10 2
1 / 8 2.1611 × 10 2 1.0029.72.2292 × 10 2 1.0019.22.2318 × 10 2
1 / 16 5.4027 × 10 3 1.009645.5751 × 10 3 1.006065.5815 × 10 3
Table 6. The error and CPU cost t = 0.2 in the Crank–Nicolson scheme.
Table 6. The error and CPU cost t = 0.2 in the Crank–Nicolson scheme.
H u n u h n 1 OrderTime (s) u n u ^ h n 1 OrderTime (s) u n U h n 1
1 / 4 9.5565 × 10 2 /3.151.0241 × 10 1 /2.271.0288 × 10 1
1 / 8 2.3884 × 10 2 1.0059.82.5708 × 10 2 1.0038.72.5825 × 10 2
1 / 16 5.9709 × 10 3 1.0021436.4347 × 10 3 1.0011166.4640 × 10 3
Table 7. The error and CPU cost at t = 0.5 in the Crank–Nicolson scheme.
Table 7. The error and CPU cost at t = 0.5 in the Crank–Nicolson scheme.
H u n u h n 1 OrderTime (s) u n u ^ h n 1 OrderTime (s) u n U h n 1
1 / 4 1.2901 × 10 1 /7.511.4629 × 10 1 /5.481.4890 × 10 1
1 / 8 3.2240 × 10 2 1.001483.6766 × 10 2 1.001183.7434 × 10 2
1 / 16 8.0599 × 10 3 1.0050279.2073 × 10 3 1.0027759.3754 × 10 3
Table 8. The error and CPU cost at t = 1.0 in the Crank–Nicolson scheme.
Table 8. The error and CPU cost at t = 1.0 in the Crank–Nicolson scheme.
H u n u h n 1 OrderTime (s) u n u ^ h n 1 OrderTime (s) u n U h n 1
1 / 4 2.1268 × 10 1 /14.92.2899 × 10 1 /10.82.3462 × 10 1
1 / 8 5.3155 × 10 2 1.002995.7344 × 10 2 1.002395.8793 × 10 2
1 / 16 1.3289 × 10 2 1.0095941.4342 × 10 2 1.0054551.4708 × 10 2
Disclaimer/Publisher’s Note: The statements, opinions and data contained in all publications are solely those of the individual author(s) and contributor(s) and not of MDPI and/or the editor(s). MDPI and/or the editor(s) disclaim responsibility for any injury to people or property resulting from any ideas, methods, instructions or products referred to in the content.

Share and Cite

MDPI and ACS Style

Wang, J.; Zhong, Z.; Tian, Z.; Liu, Y. A Two-Grid Algorithm of the Finite Element Method for the Two-Dimensional Time-Dependent Schrödinger Equation. Mathematics 2024, 12, 726. https://doi.org/10.3390/math12050726

AMA Style

Wang J, Zhong Z, Tian Z, Liu Y. A Two-Grid Algorithm of the Finite Element Method for the Two-Dimensional Time-Dependent Schrödinger Equation. Mathematics. 2024; 12(5):726. https://doi.org/10.3390/math12050726

Chicago/Turabian Style

Wang, Jianyun, Zixin Zhong, Zhikun Tian, and Ying Liu. 2024. "A Two-Grid Algorithm of the Finite Element Method for the Two-Dimensional Time-Dependent Schrödinger Equation" Mathematics 12, no. 5: 726. https://doi.org/10.3390/math12050726

Note that from the first issue of 2016, this journal uses article numbers instead of page numbers. See further details here.

Article Metrics

Back to TopTop