This paper was converted on www.awesomepapers.org from LaTeX by an anonymous user.
Want to know more? Visit the Converter page.

A New Reduced Basis Method for Parabolic Equations Based on Single-Eigenvalue Acceleration

Qijia Zhai, Qingguo Hong, Xiaoping Xie
Abstract

In this paper, we develop a new reduced basis (RB) method, named as Single Eigenvalue Acceleration Method (SEAM), for second order parabolic equations with homogeneous Dirichlet boundary conditions. The high-fidelity numerical method adopts the backward Euler scheme and conforming simplicial finite elements for the temporal and spatial discretizations, respectively. Under the assumption that the time step size is sufficiently small and time steps are not very large, we show that the singular value distribution of the high-fidelity solution matrix UU is close to that of a rank one matrix. We select the eigenfunction associated to the principal eigenvalue of the matrix UUU^{\top}U as the basis of Proper Orthogonal Decomposition (POD) method so as to obtain SEAM and a parallel SEAM. Numerical experiments confirm the efficiency of the new method.

Keywords: Reduced basis method; Proper orthogonal decomposition; Singular value; Second order parabolic equation

1 Introduction

The Reduced Basis (RB) method is a type of model order reduction approach for numerical approximation of problems involving repeated solution of differential equations generated in engineering and applied sciences. It was first proposed in [2] for the analysis of nonlinear structures in the 1970s, and later extended to many other problems such as partial differential equations (PDEs) with multiple parameters or different initial conditions [9, 4, 41, 10, 11, 37, 12, 39], PDE-constrained parametric optimization and control problems [16, 34, 17, 18], and inverse problems [24, 31]. It should be mentioned that the work in [38, 48] has led to a decisive improvement in the computational aspects of RB methods, owing to an efficient criterion for the selection of the basis functions, a systematic splitting of the computational procedure into an offline (parameter-independent) phase and an online (parameter-dependent) phase, and the use of posteriori error estimates that guarantee certified numerical solutions for the reduced problems. The RB methods that include the offline and online phases as their essential constituents have become the most widely used ones.

The Proper Orthogonal Decomposition (POD) method, combined with the Galerkin projection method, is a typical RB method. It uses a set of orthonormal bases, which can represent the known data in the sense of least squares, to linearly approximate the target variables so as to obtain a low-dimensional approximate model. Since it is optimal in the least square sense, the POD method has the property of completely relying, without making any a priori assumption, on the data.

The POD method, whose predecessor was initially presented by K.Pearson[36] in 1901 as an eigenvector analysis method and was originally conceived in the framework of continuous second-order processes by Berkooz[5], has been widely used in many fields with different appellations. In the singular value analysis and sample identification, the method is called the Karhumen-Loeve expansion [21]. In statistics it is named as the principal component analysis (PCA) [19]. In geophysical fluid dynamics and meteorological sciences, it is called the empirical orthogonal function method (EOF)[33, 42]. We can also see the widespread applications of POD method in fluid dynamics and viscous structures[3, 8, 15, 25, 35, 40, 43, 44, 45], optimal fluid control problems [20, 30], numerical analysis of PDEs [26, 22, 23, 1, 6, 27, 29, 28] and machine learning [32, 47, 13, 7, 46].

In this paper, we develop a new RB/POD method, named as Single Eigenvalue Acceleration Method (SEAM), for a full discretization, using backward Euler scheme for temporal discretization and continuous simplicial finite elements for spatial discretization, of second order parabolic equations with homogeneous Dirichlet boundary conditions. The idea of SEAM is inspired by a POD numerical experiment for a one-dimensional heat conduction problem:

{ut=2ux2,x(0,1),t(0,0.1],u(x,0)=sin(4πx),x(0,1),u(0,t)=u(1,t)=0,t(0,0.1].\left\{\begin{array}[]{ll}\frac{\partial u}{\partial t}=\frac{\partial^{2}u}{\partial x^{2}},&x\in(0,1),t\in(0,0.1],\\ u(x,0)=\sin(4\pi x),&x\in(0,1),\\ u(0,t)=u(1,t)=0,&t\in(0,0.1].\end{array}\right. (1)

When we focus on the numerical solution matrix UU of (1), where each column consists of the value of the numerical solution at a node, and the number of columns is the same as the number of time steps (We divide (0,T](0,T] into 1000 equal parts and DD into 99 equal parts to get the high-fidelity numerical solution; see Figure 1), we observe something interesting: the principal singular value is much larger than other singular values of the numerical solution matrix! Here we recall that the singular values of UU are the arithmetic square roots of the eigenvalues of UUU^{\top}U. Notice that when we use the POD method the choice of basis functions is often empirical. The observation tells us that we only need to choose one basis function when solving this equation with POD.

We show in Figure 1 , Figure 2 and Table 1 the SEAM (POD with one basis function) solution and computational details, respectively. We can see that when SEAM is used, the computational time can be saved greatly, and the relative error between the SEAM solution and the high-fidelity solution is very small.

Refer to caption
(a) High-fidelity numerical solution
Refer to caption
(b) SEAM solution
Figure 1: High-Fidelity numerical solution and SEAM solution for (1)
Refer to caption
(a) The first 20 eigenvalues of UUU^{\top}U (from big to small): the 1st one is 1007.63, and the 2nd one is 8.7e-9
Refer to caption
(b) Relative error between high-fidelity solution and SEAM solution
Figure 2: The first 20 eigenvalues of UUU^{\top}U and relative error between SEAM solution and high-fidelity solution of (1)
High-fidelity model SEAM
Number of FEM d.o.fs (each time step) 98 Number of SEAM d.o.fs (each time step) 1
d.o.fs reduction 98:1
FE solution time 1.73s SEAM solution time 762ms
SEAM-relative error in L2L^{2}-norm 1.2e-8
Table 1: Computational details for the high-fidelity / SEAM solutions of (1).

Based on the above observation from the numerical experiment of 1d case, we investigate SEAM for d-dimensional (d=2,3) second order parabolic problems with homogeneous Dirichlet boundary conditions. Under the assumption that the time step size is sufficiently small and the time steps are not very large, we show that the singular value distribution of the high-fidelity solution matrix is very close to a reference matrix of rank one. Then we select the eigenfunction associated to the principal eigenvalue as the POD basis so as to obtain SEAM.

The rest of the paper is arranged as follows. Section 2 introduces the model problem and its full discretization. Section 3 gives the SEAM algorithm and its parallel version. Section 4 discusses the singular value distribution of numerical solution matrix, and Section 5 reports some numerical experiments. Finally, Section 6 gives concluding remarks.

2 Model problem and fully discrete scheme

Let DdD\subset\mathcal{R}^{d} (d=1,2,3d=1,2,3) be an open, bounded domain, and set DT:=D×(0,T]D_{T}:=D\times(0,T] for constant T>0T>0. We consider the following second-order parabolic problem: find u=u(x,t)u=u(x,t) such that

{ut(α(x)u)+c(x)u=f, in DT,u=u0, on D×{0},u=0, on D×[0,T],\begin{cases}u_{t}-\nabla\cdot(\alpha(x)\nabla u)+c(x)u=f,&\text{ in }D_{T},\\ u=u_{0},&\text{ on }D\times\{0\},\\ u=0,&\text{ on }\partial D\times[0,T],\end{cases} (2)

where α(x)=(αk,j(x))d×d\alpha(x)=\left(\alpha_{k,j}(x)\right)_{d\times d} with αk,j(x)=αj,k(x)W1,(D)\alpha_{k,j}(x)=\alpha_{j,k}(x)\in W^{1,\infty}(D), c(x)L(D)c(x)\in L^{\infty}(D), and f=f(x,t):DTf=f(x,t):D_{T}\rightarrow\mathcal{R} and u0(x):Du_{0}(x):D\rightarrow\mathcal{R} are given functions.

Let 𝒯h={T}\mathcal{T}_{h}=\bigcup\{T\} be a conforming shape-regular simplicial decomposition of the domain DD, and let 𝕍hH01(D)\mathbb{V}_{h}\subset H_{0}^{1}(D) be a space of standard finite elements of arbitrary order with respect to 𝒯h\mathcal{T}_{h}. Denote by {xk:k=1,2,,M}\left\{x_{k}:\ k=1,2,\cdots,M\right\} the set of all interior nodes of 𝒯h\mathcal{T}_{h}, and by {φk(x):k=1,2,,M}\{\varphi_{k}(x):\ k=1,2,\cdots,M\} the nodal basis of 𝕍h\mathbb{V}_{h} with

φk(xj)=δkjfor k,j=1,2,,M.\varphi_{k}(x_{j})=\delta_{kj}\quad\text{for }k,j=1,2,\cdots,M.

Then we have

𝕍h=span{φk:k=1,,M}.\mathbb{V}_{h}=\text{span}\left\{\varphi_{k}:\ k=1,\cdots,M\right\}.

We divide the time interval (0,T)(0,T) into a uniform grid with nodes tn=nτt_{n}=n\tau and step size τ=T/N\tau=T/N for n=0,1,,Nn=0,1,\ldots,N. For convenience we set gn:=g(tn)g^{n}:=g(t_{n}) for any function g(t)g(t).

Let πhu0𝕍h\pi_{h}u_{0}\in\mathbb{V}_{h} be the piecewise interpolation of u0u_{0}. We consider the following fully discrete scheme for (2):

For n=1,2,,Nn=1,2,...,N, find un,h𝕍hu_{n,h}\in\mathbb{V}_{h} such that

1τ(un,hun1,h,v)D+a(un,h,v)=(fn,v)D,v𝕍h,\frac{1}{\tau}\left(u_{n,h}-u_{n-1,h},v\right)_{D}+a\left(u_{n,h},v\right)=\left(f_{n},v\right)_{D},\quad\forall v\in\mathbb{V}_{h}, (3)

with initial data u0,h=πhu0u_{0,h}=\pi_{h}u^{0}. Here (,)D(\cdot,\cdot)_{D} denotes the L2L^{2}-inner product on DD, and a(u,v):=(αu,v)D+(cun,h,v)Da\left(u,v\right):=\left(\alpha\nabla u,\nabla v\right)_{D}+\left(cu_{n,h},v\right)_{D}.

Introduce the numerical solution vector UnU_{n}, the mass matrix \mathcal{M}, the total stiffness matrix 𝒮\mathcal{S}, and the load vector FF, defined respectively by

Un:=(un,h(x1),,un,h(xM)),n=0,1,,N,U_{n}:=\left(u_{n,h}(x_{1}),\cdots,u_{n,h}(x_{M})\right)^{\top},\quad n=0,1,\cdots,N,
:=((φk,φj)D)M×M,𝒮:=(a(φk,φj))M×M,F:=((f,φ1),,(f,φM)).\mathcal{M}:=\left((\varphi_{k},\varphi_{j})_{D}\right)_{M\times M},\quad\mathcal{S}:=\left(a(\varphi_{k},\varphi_{j})\right)_{M\times M},\quad F:=\left(\left(f,\varphi_{1}\right),\cdots,\left(f,\varphi_{M}\right)\right)^{\top}.

Notice that \mathcal{M} and 𝒮\mathcal{S} are both symmetric and positive definite. Since un,h(x)=k=1Mun,h(xk)φk(x),u_{n,h}(x)=\sum\limits_{k=1}^{M}u_{n,h}(x_{k})\varphi_{k}(x), for a given U0U_{0} the system (3) is of the matrix form

(+τ𝒮)Un=Un1+τF.(\mathcal{M}+\tau\mathcal{S})U_{n}=\mathcal{M}U_{n-1}+\tau F. (4)

3 Single-Eigenvalue Acceleration Method

In this section, we give the SEAM algorithm, based on POD, and a parallel version. Let UnU_{n} be the high-fidelity numerical solution vector defined by (4) for each nn, and let

U:=(U0,U1,,Un),n=0,1,,N,U:=\left(U_{0},U_{1},\cdots,U_{n}\right),\quad n=0,1,\cdots,N, (5)

be the numerical solution matrix of (2). Denote

X:=UU,X:=U^{\top}U, (6)

and let

λ0(X)λ1(X)λn(X)0\lambda_{0}(X)\geq\lambda_{1}(X)\geq\cdots\geq\lambda_{n}(X)\geq 0

be the eigenvalues of XX, then the singular values of UU are

λ0(X),λ1(X),,λn(X).\sqrt{\lambda_{0}(X)},\sqrt{\lambda_{1}(X)},\cdots,\sqrt{\lambda_{n}(X)}.

Set

𝒰^:=span{U0,U1,,Un},d^:=dim𝒰^.\widehat{\mathcal{U}}:=\operatorname{span}\left\{U_{0},U_{1},\cdots,U_{n}\right\},\quad\hat{d}:=\operatorname{dim}\widehat{\mathcal{U}}.

Without loss of generality, we assume that 1d^<<M1\leq\hat{d}<<M. The POD method is to find the standard orthogonal basis functions βj\beta_{j} (j=1,2,,p)(j=1,2,\cdots,p) of 𝒰^\widehat{\mathcal{U}} such that for any pp, 11\leq pd^p\leq\hat{d}, the mean square error between UnU_{n} (n=0,1,)(n=0,1,\cdots) and its orthogonal projection onto the space span{β1,,βp}\text{span}\{\beta_{1},\cdots,\beta_{p}\} is minimized on average, i.e.

min{βj}j=1p𝒰^k=0nUkj=1pUk,βjβj22.\min_{\left\{\beta_{j}\right\}_{j=1}^{p}\subset\widehat{\mathcal{U}}}\sum_{k=0}^{n}\left\|{U}_{k}-\sum_{j=1}^{p}\langle{U}_{k},\beta_{j}\rangle\beta_{j}\right\|_{2}^{2}. (7)

A solution {βj}j=1p\left\{\beta_{j}\right\}_{j=1}^{p} to (7) is called a POD-basis of rank pp.

We will show later (cf. Theorem 4.1 and Corollary 4.1) that the non-zero eigenvalues of XX except for the principal eigenvalue are close to zero if nn is not very large and the time step size τ\tau is small enough. Based upon the theoretical result, we choose p=1p=1 in the POD method (7). This means that we only need to use the biggest eigenvalue λ0(X)\lambda_{0}(X) and the associated eigenvector 𝐛0=(b0,b1,,bn)T\mathbf{b}_{0}=(b_{0},b_{1},\cdots,b_{n})^{T} to obtain the rank 1 POD basis (cf. [43])

β1=1λ0k=0nbkUk.\beta_{1}=\frac{1}{\sqrt{\lambda_{0}}}\sum_{k=0}^{n}b_{k}{U}_{k}.

For convenience, we name the POD method with p=1p=1 as Single Eigenvalue Acceleration Method (SEAM), and the corresponding SEAM scheme for the full discretization (4) is as follows:

Given α0=β1U0,\alpha_{0}=\beta_{1}^{\top}U_{0}\in\Re, for k=1,2,,n,k=1,2,\cdots,n, the SEAM approximation solution UkseamU^{seam}_{k} at kk-th time step is obtained by

{β1(+τ𝒮)β1αk=β1β1αk1+τβ1F,Ukseam=αkβ1.\left\{\begin{array}[]{l}\beta_{1}^{\top}(\mathcal{M}+\tau\mathcal{S})\beta_{1}\alpha_{k}=\beta_{1}^{\top}\mathcal{M}\beta_{1}\alpha_{k-1}+\tau\beta_{1}^{\top}F,\\ U^{seam}_{k}=\alpha_{k}\beta_{1}.\end{array}\right. (8)

Note that the coefficients β1(+τ𝒮)β1\beta_{1}^{\top}(\mathcal{M}+\tau\mathcal{S})\beta_{1} and β1β1\beta_{1}^{\top}\mathcal{M}\beta_{1} in (8) are positive constants.

By Theorem 4.1 the model-order-reduction error of SEAM (8) is (cf. [39])

k=0nUkUkseam22=k=1nλk(X)Cn2τ,\sum_{k=0}^{n}\left\|{U}_{k}-U^{seam}_{k}\right\|_{2}^{2}=\sum_{k=1}^{n}\lambda_{k}(X)\leq Cn^{2}\tau,

where CC is a positive constant independent of nn and τ\tau. This means that the SEAM algorithm may be inaccurate when n2τn^{2}\tau is not small enough. In other words, we can not expect the desired accuracy if nn is large. To overcome such a weakness, we will give a parallel SEAM below (cf. Remark 4.3).

For simplicity of notation, we assume N+1=(n~+1)(n+1)N+1=(\tilde{n}+1)(n+1). We divide the total numerical solution matrix as

(U0,U1,,UN)=(𝔘0,𝔘1,,𝔘n~),\left(U_{0},U_{1},\cdots,U_{N}\right)=\left(\mathfrak{U}_{0},\mathfrak{U}_{1},\cdots,\mathfrak{U}_{\tilde{n}}\right),

with the submatrices

𝔘k:=(Uk(n+1),Uk(n+1)+1,,Uk(n+1)+n),k=0,1,,n~.\mathfrak{U}_{k}:=(U_{k(n+1)},U_{k(n+1)+1},\cdots,U_{k(n+1)+n}),\quad k=0,1,\cdots,\tilde{n}. (9)

Then the parallel SEAM can be described as following:

  Algorithm 1 Parallel SEAM

 

1:for k=0:n~k=0:\tilde{n} do
2:     βkPOD(𝔘k)\beta_{k}\leftarrow POD(\mathfrak{U}_{k})
3:end for
4:αk,0=βkUk(n+1),k=0,1,,n~\alpha_{k,0}=\beta_{k}^{\top}U_{k(n+1)},\quad k=0,1,\cdots,\tilde{n}
5:for j=1:nj=1:n do
6:     βk(+τ𝒮)βkαk,j=βkβkαk,j1+τβkF,k=0,1,,n~\beta_{k}^{\top}(\mathcal{M}+\tau\mathcal{S})\beta_{k}\alpha_{k,j}=\beta_{k}^{\top}\mathcal{M}\beta_{k}\alpha_{k,j-1}+\tau\beta_{k}^{\top}F,\quad k=0,1,\cdots,\tilde{n}
7:end for
8:output 𝔘kseam=βk(αk,0,αk,1,,αk,n),k=0,1,,n~.\mathfrak{U}^{seam}_{k}=\beta_{k}\left(\alpha_{k,0},\alpha_{k,1},\cdots,\alpha_{k,n}\right),\quad k=0,1,\cdots,\tilde{n}.

 

4 Singular Value Distribution of Numerical Solution Matrix

In this section, we apply a perturbation technique to investigate the singular value distribution of the numerical solution matrix UU in (5). We need the following result due to Hoffman and Wielandt [14]:

Lemma 4.1

If AA and EE are two (n+1)×(n+1)(n+1)\times(n+1) symmetric matrices, then there hold

k=0n(λk(A+E)λk(A))2E𝔉2\sum_{k=0}^{n}\left(\lambda_{k}(A+E)-\lambda_{k}(A)\right)^{2}\leq\|E\|_{\mathfrak{F}}^{2}

and

λn(E)λk(A+E)λk(A)λ0(E),0kn,\lambda_{n}(E)\leq\lambda_{k}(A+E)-\lambda_{k}(A)\leq\lambda_{0}(E),\quad 0\leq k\leq n,

where λn(E)λn1(E)λ0(E)\lambda_{n}(E)\leq\lambda_{n-1}(E)\leq\cdots\leq\lambda_{0}(E) are the eigenvalues of EE, and E𝔉=k=0nj=0nEkj2\|E\|_{\mathfrak{F}}=\sqrt{\sum\limits_{k=0}^{n}\sum\limits_{j=0}^{n}E_{kj}^{2}} is the Frobenius norm of EE.

Let us turn back to the matrix equation (4). Since

+τ𝒮=1/2(I+τ1/2𝒮1/2)1/2,\mathcal{M}+\tau\mathcal{S}=\mathcal{M}^{1/2}(I+\tau\mathcal{M}^{-1/2}\mathcal{S}\mathcal{M}^{-1/2})\mathcal{M}^{1/2},

we rewrite (4) as

Un=1/2(I+τ𝓐)11/2Un1+τ1/2(I+τ𝓐)11/2FU_{n}=\mathcal{M}^{-1/2}\left(I+\tau\bm{\mathcal{A}}\right)^{-1}\mathcal{M}^{1/2}U_{n-1}+\tau\mathcal{M}^{-1/2}\left(I+\tau\bm{\mathcal{A}}\right)^{-1}\mathcal{M}^{-1/2}F (10)

with 𝓐=1/2𝒮1/2\bm{\mathcal{A}}=\mathcal{M}^{-1/2}\mathcal{S}\mathcal{M}^{-1/2}, for a given U0U_{0} and n=1,2,,Nn=1,2,...,N.

In what follows we assume that the time step τ(0,1)\tau\in(0,1) is small enough such that

max{τ𝓐2,Iτ𝓐2}<1.\max\{\tau\|\bm{\mathcal{A}}\|_{2},\|I-\tau\bm{\mathcal{A}}\|_{2}\}<1. (11)

By noticing that 𝓐\bm{\mathcal{A}} is SPD, this assumption is reasonable.

Let ρ()\rho(\cdot) represent the spectral radius of a matrix. As (11) implies ρ(τ𝓐)<1\rho(\tau\bm{\mathcal{A}})<1, we have

(I+τ𝓐)1=k=0(1)k(τ𝓐)k=Iτ𝓐+O(τ2).\left(I+\tau\bm{\mathcal{A}}\right)^{-1}=\sum_{k=0}^{\infty}(-1)^{k}(\tau\bm{\mathcal{A}})^{k}=I-\tau\bm{\mathcal{A}}+O\left(\tau^{2}\right). (12)

In the case of F=0F=0, (10) is reduced to

{U~0=U0,U~n=1/2(I+τ𝓐)11/2U~n1,1nN.\left\{\begin{array}[]{l}\tilde{U}_{0}=U_{0},\\ \widetilde{U}_{n}=\mathcal{M}^{-1/2}\left(I+\tau\bm{\mathcal{A}}\right)^{-1}\mathcal{M}^{1/2}\widetilde{U}_{n-1},\quad 1\leq n\leq N.\end{array}\right. (13)

Inspired by (12), for n=0,1,2,n=0,1,2,\cdots we define UnU_{n}^{*} by

{U0=U0,Un=1/2(Iτ𝓐)1/2Un1=1/2(Iτ𝓐)n1/2U0,\left\{\begin{array}[]{l}U_{0}^{*}=U_{0},\\ U_{n}^{*}=\mathcal{M}^{-1/2}\left(I-\tau\bm{\mathcal{A}}\right)\mathcal{M}^{1/2}U_{*}^{n-1}=\mathcal{M}^{-1/2}\left(I-\tau\bm{\mathcal{A}}\right)^{n}\mathcal{M}^{1/2}U_{0}^{*},\end{array}\right. (14)

and define U¯n\bar{U}_{n}^{*} by

{U¯0=U0,U¯n=1/2(Iτ𝓐2I)1/2U¯n1=(1τ𝓐2)nU¯0.\left\{\begin{array}[]{l}\bar{U}_{0}^{*}=U_{0},\\ \bar{U}_{n}^{*}=\mathcal{M}^{-1/2}\left(I-\tau\|\bm{\mathcal{A}}\|_{2}I\right)\mathcal{M}^{1/2}\bar{U}_{*}^{n-1}=\left(1-\tau\|\bm{\mathcal{A}}\|_{2}\right)^{n}\bar{U}_{0}^{*}.\end{array}\right. (15)

Denote

U~:=(U~0,U~1,,U~n),U:=(U0,U1,,Un),U¯:=(U¯0,U¯1,,,U¯n),\widetilde{U}:=(\widetilde{U}_{0},\widetilde{U}_{1},\cdots,\widetilde{U}_{n}),\quad U_{*}:=\left(U_{0}^{*},{U}_{1}^{*},\cdots,{U}_{n}^{*}\right),\quad\bar{U}_{*}:=\left(\bar{U}_{0}^{*},\bar{U}_{1}^{*},,\cdots,\bar{U}_{n}^{*}\right),
X~:=U~U~,X¯:=U¯U¯.\widetilde{X}:=\widetilde{U}^{\top}\widetilde{U},\quad\bar{X}_{*}:=\bar{U}_{*}^{\top}\bar{U}_{*}.
Remark 4.1

We easily see that the rank of U¯\bar{U}_{*} is at most 1, which implies that U¯\bar{U}_{*} has at most one non-zero singular value, and thus X¯\bar{X}_{*} has at most one nonzero eigenvalue.

In the sequel we use aba\lesssim b to denote aCba\leq Cb for simplicity, where CC is a generic positive constant independent of nn and τ\tau and may be different at its each occurrence.

The following lemma shows that X¯\bar{X}_{*} can be viewed as a perturbation of X~\widetilde{X} in some sense.

Lemma 4.2

Assume that τ\tau is small enough such that (11) holds, then we have

X~X¯𝔉2n4τ2.\displaystyle\|\widetilde{X}-\bar{X}_{*}\|_{\mathfrak{F}}^{2}\lesssim n^{4}\tau^{2}. (16)

Proof:

From (13)-(15) we get

T~:=U~U=(𝟎,θ~1U0,θ~2U0,θ~nU0),\displaystyle\widetilde{T}_{*}:=\widetilde{U}-U_{*}=\left(\bm{0},\tilde{\theta}_{1}U_{0},\tilde{\theta}_{2}U_{0}\cdots,\tilde{\theta}_{n}U_{0}\right),
T¯:=UU¯=(𝟎,θ¯1U0,θ¯2U0,,θ¯nU0),\displaystyle\bar{T}_{*}:=U_{*}-\bar{U}_{*}=\left(\bm{0},\bar{\theta}_{1}U_{0},\bar{\theta}_{2}U_{0},\cdots,\bar{\theta}_{n}U_{0}\right),

where

θ~n\displaystyle\tilde{\theta}_{n} :=1/2[(Iτ𝓐+O(τ2))n(Iτ𝓐)n]1/2\displaystyle:=\mathcal{M}^{-1/2}\left[\left(I-\tau\bm{\mathcal{A}}+O\left(\tau^{2}\right)\right)^{n}-\left(I-\tau\bm{\mathcal{A}}\right)^{n}\right]\mathcal{M}^{1/2}
=1/2[k=1n(nk)(Iτ𝓐)nkO(τ2k)]1/2,\displaystyle=\mathcal{M}^{-1/2}\left[\sum\limits_{k=1}^{n}\binom{n}{k}\left(I-\tau\bm{\mathcal{A}}\right)^{n-k}O\left(\tau^{2k}\right)\right]\mathcal{M}^{1/2},
θ¯n\displaystyle\bar{\theta}_{n} :=1/2[(Iτ𝓐)n(Iτ𝓐2I)n]1/2\displaystyle:=\mathcal{M}^{-1/2}\left[\left(I-\tau\bm{\mathcal{A}}\right)^{n}-\left(I-\tau\|\bm{\mathcal{A}}\|_{2}I\right)^{n}\right]\mathcal{M}^{1/2}
=τ1/2[(𝓐2I𝓐)k=1n(1τ𝓐2)k1(Iτ𝓐)nk]1/2.\displaystyle=\tau\mathcal{M}^{-1/2}\left[\left(\|\bm{\mathcal{A}}\|_{2}I-\bm{\mathcal{A}}\right)\sum\limits_{k=1}^{n}\left(1-\tau\|\bm{\mathcal{A}}\|_{2}\right)^{k-1}\left(I-\tau\bm{\mathcal{A}}\right)^{n-k}\right]\mathcal{M}^{1/2}.

Thus,

X~X¯\displaystyle\widetilde{X}-\bar{X}_{*} =\displaystyle= (U~U~UU)+(UUU¯U¯)\displaystyle(\widetilde{U}^{\top}\widetilde{U}-U_{*}^{\top}U_{*})+(U_{*}^{\top}U_{*}-\bar{U}_{*}^{\top}\bar{U}_{*}) (17)
=\displaystyle= ((U+T~)(U+T~)UU)+((U¯+T¯)(U¯+T¯)U¯U¯)\displaystyle\left((U_{*}+\widetilde{T}_{*})^{\top}(U_{*}+\widetilde{T}_{*})-U_{*}^{\top}U_{*}\right)+\left((\bar{U}_{*}+\bar{T}_{*})^{\top}(\bar{U}_{*}+\bar{T}_{*})-\bar{U}_{*}^{\top}\bar{U}_{*}\right)
=\displaystyle= (UT~+T~U+T~T~)+(U¯T¯+T¯U¯+T¯T¯)\displaystyle(U_{*}^{\top}\widetilde{T}_{*}+\widetilde{T}_{*}^{\top}U_{*}+\widetilde{T}_{*}^{\top}\widetilde{T}_{*})+(\bar{U}_{*}^{\top}\bar{T}_{*}+\bar{T}_{*}^{\top}\bar{U}_{*}+\bar{T}_{*}^{\top}\bar{T}_{*})
=:\displaystyle=: E+E¯.\displaystyle E_{*}+\bar{E}_{*}.

From the assumption (11) and the definitions of UU_{*}, U¯\bar{U}_{*}, T~\widetilde{T}_{*} and T¯\bar{T}_{*}, we have the following estimates:

U𝔉2\displaystyle\|U_{*}\|_{\mathfrak{F}}^{2} \displaystyle\leq 1/2𝔉2k=0nIτ𝓐22k1/222U022\displaystyle\|\mathcal{M}^{-1/2}\|_{\mathfrak{F}}^{2}\sum_{k=0}^{n}\|I-\tau\bm{\mathcal{A}}\|_{2}^{2k}\|\mathcal{M}^{1/2}\|_{2}^{2}\|U_{0}\|_{2}^{2}
\displaystyle\leq (n+1)1/2𝔉21/222U022,\displaystyle(n+1)\|\mathcal{M}^{-1/2}\|_{\mathfrak{F}}^{2}\|\mathcal{M}^{1/2}\|_{2}^{2}\|U_{0}\|_{2}^{2},
U¯𝔉2\displaystyle\|\bar{U}_{*}\|_{\mathfrak{F}}^{2} \displaystyle\leq k=0n(1τ𝓐2)2kU022(n+1)U022,\displaystyle\sum_{k=0}^{n}(1-\tau\|\bm{\mathcal{A}}\|_{2})^{2k}\|U_{0}\|_{2}^{2}\leq(n+1)\|U_{0}\|_{2}^{2},
T~𝔉2\displaystyle\|\widetilde{T}_{*}\|_{\mathfrak{F}}^{2} \displaystyle\leq 1/2𝔉2k=1n[j=1k(kj)Iτ𝓐2kjO(τ2j)]21/222U022\displaystyle\|\mathcal{M}^{-1/2}\|_{\mathfrak{F}}^{2}\sum_{k=1}^{n}\left[\sum\limits_{j=1}^{k}\binom{k}{j}\|I-\tau\bm{\mathcal{A}}\|_{2}^{k-j}O\left(\tau^{2j}\right)\right]^{2}\|\mathcal{M}^{1/2}\|_{2}^{2}\|U_{0}\|_{2}^{2}
\displaystyle\leq 1/2𝔉2k=1n[j=1k(kj)O(τ2j)]21/222U022\displaystyle\|\mathcal{M}^{-1/2}\|_{\mathfrak{F}}^{2}\sum_{k=1}^{n}\left[\sum\limits_{j=1}^{k}\binom{k}{j}O\left(\tau^{2j}\right)\right]^{2}\|\mathcal{M}^{1/2}\|_{2}^{2}\|U_{0}\|_{2}^{2}
\displaystyle\leq 1/2𝔉2k=1n[j=1kO(τj)]21/222U022\displaystyle\|\mathcal{M}^{-1/2}\|_{\mathfrak{F}}^{2}\sum_{k=1}^{n}\left[\sum\limits_{j=1}^{k}O\left(\tau^{j}\right)\right]^{2}\|\mathcal{M}^{1/2}\|_{2}^{2}\|U_{0}\|_{2}^{2}
\displaystyle\lesssim nτ21/2𝔉21/222U022,\displaystyle n\tau^{2}\|\mathcal{M}^{-1/2}\|_{\mathfrak{F}}^{2}\|\mathcal{M}^{1/2}\|_{2}^{2}\|U_{0}\|_{2}^{2},

and

T¯𝔉2\displaystyle\|\bar{T}_{*}\|_{\mathfrak{F}}^{2} τ21/2𝔉2𝓐2I𝓐22k=1n[j=1k(1τ𝓐2)j1Iτ𝓐kj]21/222U022\displaystyle\leq\tau^{2}\|\mathcal{M}^{-1/2}\|_{\mathfrak{F}}^{2}\|\|\bm{\mathcal{A}}\|_{2}I-\bm{\mathcal{A}}\|_{2}^{2}\sum_{k=1}^{n}\left[\sum\limits_{j=1}^{k}\left(1-\tau\|\bm{\mathcal{A}}\|_{2}\right)^{j-1}\|I-\tau\bm{\mathcal{A}}\|^{k-j}\right]^{2}\|\mathcal{M}^{1/2}\|_{2}^{2}\|U_{0}\|_{2}^{2}
τ21/2𝔉2𝓐2I𝓐22(k=1nk2)1/222U022\displaystyle\leq\tau^{2}\|\mathcal{M}^{-1/2}\|_{\mathfrak{F}}^{2}\|\|\bm{\mathcal{A}}\|_{2}I-\bm{\mathcal{A}}\|_{2}^{2}(\sum_{k=1}^{n}k^{2})\|\mathcal{M}^{1/2}\|_{2}^{2}\|U_{0}\|_{2}^{2}
n3τ21/2𝔉2𝓐2I𝓐221/222U022,\displaystyle\lesssim n^{3}\tau^{2}\|\mathcal{M}^{-1/2}\|_{\mathfrak{F}}^{2}\|\|\bm{\mathcal{A}}\|_{2}I-\bm{\mathcal{A}}\|_{2}^{2}\|\mathcal{M}^{1/2}\|_{2}^{2}\|U_{0}\|_{2}^{2},

Consequently, we obtain

E𝔉2\displaystyle\|E_{*}\|_{\mathfrak{F}}^{2} =UT~+T~U+T~T~𝔉2\displaystyle=\|U_{*}^{\top}\widetilde{T}_{*}+\widetilde{T}_{*}^{\top}U_{*}+\widetilde{T}_{*}^{\top}\widetilde{T}_{*}\|_{\mathfrak{F}}^{2}
8U𝔉2T~𝔉2+2T~𝔉4\displaystyle\leq 8\|U_{*}\|_{\mathfrak{F}}^{2}\|\widetilde{T}_{*}\|_{\mathfrak{F}}^{2}+2\|\widetilde{T}_{*}\|_{\mathfrak{F}}^{4}
n2τ21/2𝔉41/224U024\displaystyle\lesssim n^{2}\tau^{2}\|\mathcal{M}^{-1/2}\|_{\mathfrak{F}}^{4}\|\mathcal{M}^{1/2}\|_{2}^{4}\|U_{0}\|_{2}^{4}
n2τ2,\displaystyle\lesssim n^{2}\tau^{2},
E¯𝔉2\displaystyle\|\bar{E}_{*}\|_{\mathfrak{F}}^{2} =U¯T¯+T¯U¯+T¯T¯𝔉2\displaystyle=\|\bar{U}_{*}^{\top}\bar{T}_{*}+\bar{T}_{*}^{\top}\bar{U}_{*}+\bar{T}_{*}^{\top}\bar{T}_{*}\|_{\mathfrak{F}}^{2}
8U¯𝔉2T¯𝔉2+2T¯𝔉4\displaystyle\leq 8\|\bar{U}_{*}\|_{\mathfrak{F}}^{2}\|\bar{T}_{*}\|_{\mathfrak{F}}^{2}+2\|\bar{T}_{*}\|_{\mathfrak{F}}^{4}
(n4τ2U022+n6τ41/2𝔉2𝓐2I𝓐221/222U022)\displaystyle\lesssim\left(n^{4}\tau^{2}\|U_{0}\|_{2}^{2}+n^{6}\tau^{4}\|\mathcal{M}^{-1/2}\|_{\mathfrak{F}}^{2}\|\|\bm{\mathcal{A}}\|_{2}I-\bm{\mathcal{A}}\|_{2}^{2}\|\mathcal{M}^{1/2}\|_{2}^{2}\|U_{0}\|_{2}^{2}\right)
1/2𝔉2𝓐2I𝓐221/222U022\displaystyle\quad\cdot\|\mathcal{M}^{-1/2}\|_{\mathfrak{F}}^{2}\|\|\bm{\mathcal{A}}\|_{2}I-\bm{\mathcal{A}}\|_{2}^{2}\|\mathcal{M}^{1/2}\|_{2}^{2}\|U_{0}\|_{2}^{2}
n4τ2,\displaystyle\lesssim n^{4}\tau^{2},

which, together with (17), yields

X~X¯𝔉2E𝔉2+E¯𝔉2n2τ2+n4τ2n4τ2.\|\widetilde{X}-\bar{X}_{*}\|_{\mathfrak{F}}^{2}\leq\|E_{*}\|_{\mathfrak{F}}^{2}+\|\bar{E}_{*}\|_{\mathfrak{F}}^{2}\lesssim n^{2}\tau^{2}+n^{4}\tau^{2}\lesssim n^{4}\tau^{2}.

\square

Based on Lemma 4.2, we can get an error estimate between X=UU{X}=U^{\top}U X¯=U¯U¯\bar{X}=\bar{U}^{\top}\bar{U} and :

Lemma 4.3

Assume that τ\tau is small enough such that (11) holds, then we have

XX¯𝔉2n4τ2.\displaystyle\|X-\bar{X}_{*}\|_{\mathfrak{F}}^{2}\lesssim n^{4}\tau^{2}. (18)

Proof:

From (10) and (13) it follows

UnU~n=τ1/2k=1n(I+τ𝓐)k1/2F,n=1,2,.U_{n}-\widetilde{U}_{n}=\tau\mathcal{M}^{-1/2}\sum\limits_{k=1}^{n}\left(I+\tau\bm{\mathcal{A}}\right)^{-k}\mathcal{M}^{-1/2}F,\quad n=1,2,\cdots. (19)

Recalling that U~=(U~0,U~1,,U~n)\widetilde{U}=(\widetilde{U}_{0},\widetilde{U}_{1},\cdots,\widetilde{U}_{n}) and U=(U0,U1,,Un),U=\left(U_{0},{U}_{1},\cdots,{U}_{n}\right), we have

T:=UU~=τ(𝟎,θ1F,,θnF),T_{*}:=U-\widetilde{U}=\tau\left(\bm{0},\theta_{1}F,\cdots,\theta_{n}F\right),

where

θn\displaystyle{\theta}_{n} :=1/2k=1n(I+τ𝓐)k1/2.\displaystyle:=\mathcal{M}^{-1/2}\sum_{k=1}^{n}\left(I+\tau\bm{\mathcal{A}}\right)^{-k}\mathcal{M}^{-1/2}.

Then we obtain

XX~\displaystyle{X}-\widetilde{X} =(U~+T)(U~+T)U~U~\displaystyle=(\widetilde{U}+T_{*})^{\top}(\widetilde{U}+T_{*})-\widetilde{U}^{\top}\widetilde{U}
=U~T+TU~+TT.\displaystyle=\widetilde{U}^{\top}T_{*}+T_{*}^{\top}\widetilde{U}+T_{*}^{\top}T_{*}.

By (11) it is easy to show that

U~𝔉2n,T𝔉2nτ2F𝔉2.\|\widetilde{U}\|_{\mathfrak{F}}^{2}\lesssim n,\quad\|T_{*}\|_{\mathfrak{F}}^{2}\lesssim n\tau^{2}\|F\|_{\mathfrak{F}}^{2}.

As a result, we get

XX~𝔉2\displaystyle\|{X}-\widetilde{X}\|_{\mathfrak{F}}^{2} n2τ2F𝔉2+n2τ4F𝔉4n2τ2,\displaystyle\lesssim n^{2}\tau^{2}\|F\|_{\mathfrak{F}}^{2}+n^{2}\tau^{4}\|F\|_{\mathfrak{F}}^{4}\lesssim n^{2}\tau^{2},

which, together with the triangle inequality and Lemma 4.2, yields the desired estimate. \square

Using Remark 4.1 and Lemmas 4.1 and 4.2, we immediately obtain the following main conclusion for the full discretization (10):

Theorem 4.1

Assume that τ\tau is small enough such that (11) holds, then we have

(λ0(X)λ0(X¯))2+k=1nλk(X)2n4τ2.\displaystyle\left(\lambda_{0}({X})-\lambda_{0}(\bar{X}_{*})\right)^{2}+\sum\limits_{k=1}^{n}\lambda_{k}({X})^{2}\lesssim n^{4}\tau^{2}. (20)

This theorem directly yields the following result:

Corollary 4.1

Assume that τ\tau is small enough such that (11) holds, and that n=O(τ12+ϵ)n=O(\tau^{-\frac{1}{2}+\epsilon}) for some ϵ(0,12)\epsilon\in(0,\frac{1}{2}), then we have

(λ0(X)λ0(X¯))2+k=1nλk2(X)τ4ϵ.\displaystyle\left(\lambda_{0}(X)-\lambda_{0}(\bar{X}_{*})\right)^{2}+\sum_{k=1}^{n}\lambda_{k}^{2}(X)\lesssim\tau^{4\epsilon}. (21)
Remark 4.2

From Corollary 4.1, we can see that each singular value of the high-fidelity solution matrix U{U} is a small perturbation of the corresponding singular value of the reference matrix U¯\bar{U}_{*}, provided that n=O(τ12+ϵ)n=O(\tau^{-\frac{1}{2}+\epsilon}). Since U¯\bar{U}_{*} has at most one non-zero singular value, all the singular values of UU, except for the largest one, are then close to zero.

Remark 4.3

From the analysis we know that Corollary 4.1 holds not only for U=(U0,U1,,Un)U=(U_{0},U_{1},\cdots,U_{n}), but also for U=(Uk,Uk+1,,Uk+n)U=(U_{k},U_{k+1},\cdots,U_{k+n}) with k=0,1,k=0,1,\cdots. This motivates the parallel SEAM in Section 3.

5 Numerical Results

This section provides some numerical experiments to verify the performance of SEAM for the fully discrete scheme (10) using continuous linear finite elements. All the tests are performed on a 12th-Gen Intel 3.20 GHz Core i9 computer.

5.1 Two-dimensional tests

We consider the following two-dimensional problem:

{ut=α1(x,y)2ux2+α2(x,y)2uy2c(x,y)u+f, in D×(0,T],u=u0, on D×{0},u=0, on D×[0,T],\left\{\begin{array}[]{ll}\frac{\partial u}{\partial t}=\alpha_{1}(x,y)\frac{\partial^{2}u}{\partial x^{2}}+\alpha_{2}(x,y)\frac{\partial^{2}u}{\partial y^{2}}-c(x,y)u+f,&\text{ in }D\times(0,T],\\ u=u_{0},&\text{ on }D\times\{0\},\\ u=0,&\text{ on }\partial D\times[0,T],\end{array}\right. (22)

where D=(0,1)×(0,1)D=(0,1)\times(0,1) and T=1T=1. To obtain the high-fidelity numerical solutions, we first divide the spatial domain DD uniformly into 32×32=102432\times 32=1024 squares, then divide each square into 22 isosceles right triangles. For the temporal subdivision, the coefficients αi\alpha_{i}, the initial data u0(x,y)u_{0}(x,y) and the source term ff, we consider three situations:

  • S1:

    τ=1×104\tau=1\times 10^{-4}, α1(x,y)=α2(x,y)=c(x,y)=1\alpha_{1}(x,y)=\alpha_{2}(x,y)=c(x,y)=1, u0(x,y)=sin(πxy)u_{0}(x,y)=\sin(\pi xy), and f=0,xyf=0,\ xy;

  • S2:

    τ=1×104\tau=1\times 10^{-4}, α1(x,y)=x2\alpha_{1}(x,y)=x^{2}, α2(x,y)=y2\alpha_{2}(x,y)=y^{2}, c(x,y)=π2(12x2y2)c(x,y)=\pi^{2}(1-2x^{2}y^{2}), u0(x,y)=sin(πx)sin(πy)u_{0}(x,y)=\sin(\pi x)\sin(\pi y), and f=0, 10f=0,\ 10;

  • S3:

    τ=2.5×103\tau=2.5\times 10^{-3}, α1(x,y)=x2\alpha_{1}(x,y)=x^{2}, α2(x,y)=y2\alpha_{2}(x,y)=y^{2}, c(x,y)=π2(12x2y2)c(x,y)=\pi^{2}(1-2x^{2}y^{2}), u0(x,y)=sin(πx)sin(πy)u_{0}(x,y)=\sin(\pi x)\sin(\pi y), and f=0f=0.

In S1 and S2, we take n=n~=100n=\tilde{n}=100. In S3, we take n=n~=20n=\tilde{n}=20. Figures 3 to 8 show the distribution of eigenvalues of 𝔘i𝔘i\mathfrak{U}_{i}^{\top}\mathfrak{U}_{i} for different ff in situations S1,S2 and S3, where the numerical solution matrix 𝔘i\mathfrak{U}_{i} is defined by (9) for i=1,2,,n~i=1,2,\cdots,\tilde{n}. In each figure, the label ’No.s of time interval’ means the n~\tilde{n} time intervals, and the label ’No.s of eigenvalues’ means the first 5 eigenvalues in each time interval.

Figures 9 to 14 demonstrate the high-fidelity numerical solutions and the corresponding SEAM solutions of (22).

Tables 2 gives some computational details as well as the relative errors between the the SEAM solution uSEAMu_{SEAM} and the high-fidelity numerical solution ufemu_{fem}, with

SEAM-ErrorL2:=(D×(0,T](ufemuSEAM)2𝑑𝐱𝑑t)12/(D×(0,T]ufem2𝑑𝐱𝑑t)12.\text{SEAM-Error}_{L^{2}}:=\left(\int_{D\times(0,T]}(u_{fem}-u_{SEAM})^{2}d{\bf x}dt\right)^{\frac{1}{2}}/\left(\int_{D\times(0,T]}u_{fem}^{2}d{\bf x}dt\right)^{\frac{1}{2}}.

From Figures 3 to 8, we have the following observations on the distribution of eigenvalues:

  • In each case the principal eigenvalue of 𝔘i𝔘i\mathfrak{U}_{i}^{\top}\mathfrak{U}_{i} is much larger than other eigenvalues. For example, in the case S2 with f=xyf=xy, for the first 100 steps, the principal eigenvalue is 2373.15 and the second largest one is 0.000256;

  • The eigenvalues of 𝔘i𝔘i\mathfrak{U}_{i}^{\top}\mathfrak{U}_{i} except the principal one are close to zero when f=0f=0 and, though being not so close to zero, are still very small. These are consistent with Corollary 4.1;

  • As ii increases from 11 to n~\tilde{n}, the principal eigenvalues of 𝔘i𝔘i\mathfrak{U}_{i}^{\top}\mathfrak{U}_{i} gradually decrease. For example, in the case S1 with f=0f=0, the principal eigenvalues decrease from 3376.2 to 38.0. In the case S2 with f=10f=10, the principal eigenvalues decrease from 2389.5 to 1258.0. And in the case S3, the principal eigenvalues decrease from 4495.9 to 328.3.

From Figures 9 to 14 and Tables 2, we have the following observations on the SEAM solutions:

  • SEAM gives accurate numerical solutions for all cases;

  • SEAM is much faster than the original high-fidelity numerical method, due to the remarkable reduction of the size of the discrete model from M=961M=961 to p=1p=1.

Refer to caption
(a) The 1th-20th time intervals
Refer to caption
(b) The 21th-40th time intervals
Refer to caption
(c) The 41th-60th time intervals
Refer to caption
(d) The 61th-80th time intervals
Refer to caption
(e) The 81th-100th time intervals
Figure 3: The first 5 eigenvalues of 𝔘i𝔘i\mathfrak{U}_{i}^{\top}\mathfrak{U}_{i} (from big to small) for S1, f=0f=0.
Refer to caption
(a) The 1th-20th time intervals
Refer to caption
(b) The 21th-40th time intervals
Refer to caption
(c) The 41th-60th time intervals
Refer to caption
(d) The 61th-80th time intervals
Refer to caption
(e) The 81th-100th time intervals
Figure 4: The first 5 eigenvalues of 𝔘i𝔘i\mathfrak{U}_{i}^{\top}\mathfrak{U}_{i} (from big to small) for S1 with f=xyf=xy.
Refer to caption
(a) The 1th-20th time intervals
Refer to caption
(b) The 21th-40th time intervals
Refer to caption
(c) The 41th-60th time intervals
Refer to caption
(d) The 61th-80th time intervals
Refer to caption
(e) The 81th-100th time intervals
Figure 5: The first 5 eigenvalues of 𝔘i𝔘i\mathfrak{U}_{i}^{\top}\mathfrak{U}_{i} (from big to small) for S2 with f=0f=0.
Refer to caption
(a) The 1th-20th time intervals
Refer to caption
(b) The 21th-40th time intervals
Refer to caption
(c) The 41th-60th time intervals
Refer to caption
(d) The 61th-80th time intervals
Refer to caption
(e) The 81th-100th time intervals
Figure 6: The first 5 eigenvalues of 𝔘i𝔘i\mathfrak{U}_{i}^{\top}\mathfrak{U}_{i} (from big to small) for S2 with f=10f=10.
Refer to caption
(a) The 1th-20th time intervals
Refer to caption
(b) The 21th-40th time intervals
Refer to caption
(c) The 41th-60th time intervals
Refer to caption
(d) The 61th-80th time intervals
Refer to caption
(e) The 81th-100th time intervals
Figure 7: The first 5 eigenvalues of 𝔘i𝔘i\mathfrak{U}_{i}^{\top}\mathfrak{U}_{i} (from big to small) for S2 with f=xyf=xy.
Refer to caption
Figure 8: The first 5 eigenvalues of 𝔘i𝔘i\mathfrak{U}_{i}^{\top}\mathfrak{U}_{i} (from big to small) for S3 with f=0f=0.
Refer to caption
(a) t=0.25t=0.25
Refer to caption
(b) t=0.50t=0.50
Refer to caption
(c) t=0.75t=0.75
Refer to caption
(d) t=1.00t=1.00

High-fidelity numerical solution

Refer to caption
(e) t=0.25t=0.25
Refer to caption
(f) t=0.50t=0.50
Refer to caption
(g) t=0.75t=0.75
Refer to caption
(h) t=1.00t=1.00

SEAM solution

Figure 9: High-fidelity / SEAM solutions of (22) at different time for S1 with f=0f=0.
Refer to caption
(a) t=0.25t=0.25
Refer to caption
(b) t=0.50t=0.50
Refer to caption
(c) t=0.75t=0.75
Refer to caption
(d) t=1.00t=1.00

High-fidelity numerical solution

Refer to caption
(e) t=0.25t=0.25
Refer to caption
(f) t=0.50t=0.50
Refer to caption
(g) t=0.75t=0.75
Refer to caption
(h) t=1.00t=1.00

SEAM solution

Figure 10: High-fidelity / SEAM solutions of (22) at different time for S1 with f=xyf=xy.
Refer to caption
(a) t=0.25t=0.25
Refer to caption
(b) t=0.50t=0.50
Refer to caption
(c) t=0.75t=0.75
Refer to caption
(d) t=1.00t=1.00

High-fidelity numerical solution

Refer to caption
(e) t=0.25t=0.25
Refer to caption
(f) t=0.50t=0.50
Refer to caption
(g) t=0.75t=0.75
Refer to caption
(h) t=1.00t=1.00

SEAM solution

Figure 11: High-fidelity / SEAM solutions of (22) at different time for S2 with f=0f=0.
Refer to caption
(a) t=0.25t=0.25
Refer to caption
(b) t=0.50t=0.50
Refer to caption
(c) t=0.75t=0.75
Refer to caption
(d) t=1.00t=1.00

High-fidelity numerical solution

Refer to caption
(e) t=0.25t=0.25
Refer to caption
(f) t=0.50t=0.50
Refer to caption
(g) t=0.75t=0.75
Refer to caption
(h) t=1.00t=1.00

SEAM solution

Figure 12: High-fidelity / SEAM solutions of (22) at different time for S2 with f=10f=10.
Refer to caption
(a) t=0.25t=0.25
Refer to caption
(b) t=0.50t=0.50
Refer to caption
(c) t=0.75t=0.75
Refer to caption
(d) t=1.00t=1.00

High-fidelity numerical solution

Refer to caption
(e) t=0.25t=0.25
Refer to caption
(f) t=0.50t=0.50
Refer to caption
(g) t=0.75t=0.75
Refer to caption
(h) t=1.00t=1.00

SEAM solution

Figure 13: High-fidelity / SEAM solutions of (22) at different time for S2 with f=xyf=xy.
Refer to caption
(a) t=0.25t=0.25
Refer to caption
(b) t=0.50t=0.50
Refer to caption
(c) t=0.75t=0.75
Refer to caption
(d) t=1.00t=1.00

High-fidelity numerical solution

Refer to caption
(e) t=0.25t=0.25
Refer to caption
(f) t=0.50t=0.50
Refer to caption
(g) t=0.75t=0.75
Refer to caption
(h) t=1.00t=1.00

SEAM solution

Figure 14: High-fidelity / SEAM solutions of (22) at different time for S3 with f=0f=0.
High-fidelity model SEAM
Number of FEM d.o.fs (each tnt_{n}) M=961M=961 Number of SEAM d.o.fs (each tnt_{n}) p=1p=1
d.o.fs reduction 961:1961:1
FE solution time (S1,f=0S1,f=0) 8419s SEAM solution time 12s
FE solution time (S1,f=xyS1,f=xy) 8432s SEAM solution time 14s
FE solution time (S2,f=0S2,f=0) 8510s SEAM solution time 12s
FE solution time (S2,f=10S2,f=10) 8529s SEAM solution time 11s
FE solution time (S2,f=xyS2,f=xy) 8540s SEAM solution time 13s
FE solution time (S3,f=0S3,f=0) 301s SEAM solution time 3s
SEAM-ErrorL2{}_{L^{2}}(S1,f=0S1,f=0) 1.2e81.2e{-8}
SEAM-ErrorL2{}_{L^{2}}(S1,f=xyS1,f=xy) 1.4e81.4e{-8}
SEAM-ErrorL2{}_{L^{2}}(S2,f=0S2,f=0) 2.1e82.1e{-8}
SEAM-ErrorL2{}_{L^{2}}(S2,f=10S2,f=10) 1.6e81.6e{-8}
SEAM-ErrorL2{}_{L^{2}}(S2,f=xyS2,f=xy) 1.2e81.2e{-8}
SEAM-ErrorL2{}_{L^{2}}(S3,f=0S3,f=0) 1.4e81.4e{-8}
Table 2: Computational details for the high-fidelity / SEAM solutions.

5.2 A three-dimensional test

We consider the following three-dimensional problem:

{ut=2ux2+2uy2+2uz2, in D×(0,T],u=sin(2πx)sin(2πy)sin(2πz), on D×{0},u=0, on D×[0,T],\left\{\begin{array}[]{ll}\frac{\partial u}{\partial t}=\frac{\partial^{2}u}{\partial x^{2}}+\frac{\partial^{2}u}{\partial y^{2}}+\frac{\partial^{2}u}{\partial z^{2}},&\text{ in }D\times(0,T],\\ u=\sin(2\pi x)\sin(2\pi y)\sin(2\pi z),&\text{ on }D\times\{0\},\\ u=0,&\text{ on }\partial D\times[0,T],\end{array}\right. (23)

where D=(0,1)×(0,1)×(0,1)D=(0,1)\times(0,1)\times(0,1) and T=1T=1. To obtain the high-fidelity numerical solution, we first divide the spatial domain DD uniformly into 32×32×32=3276832\times 32\times 32=32768 cubes, then divide each cube into 66 tetrahedrons, and for the temporal subdivision we still take τ=2.5×103\tau=2.5\times 10^{-3} and n=n~=20n=\tilde{n}=20 in the full discretization (3).

Figure 15 shows the distribution of eigenvalues of 𝔘i𝔘i\mathfrak{U}_{i}^{\top}\mathfrak{U}_{i}, which is consistent with Corollary 4.1. Figure 16 shows the high-fidelity / SEAM solutions of (23), and Table 3 gives some computational details as well as the relative errors between the the SEAM solution and the high-fidelity numerical solution. We can see that the SEAM algorithm yields an accurate approximation solution and is much faster than the high-fidelity numerical method, due to the remarkable reduction of the size of the discrete model from M=29397M=29397 to p=1p=1.

Refer to caption
Figure 15: The first 5 eigenvalues of 𝔘i𝔘i\mathfrak{U}_{i}^{\top}\mathfrak{U}_{i} (from big to small) for (23).
Refer to caption
(a) t=0.25t=0.25
Refer to caption
(b) t=0.50t=0.50
Refer to caption
(c) t=0.75t=0.75
Refer to caption
(d) t=1.00t=1.00

High-fidelity numerical solution

Refer to caption
(e) t=0.25t=0.25
Refer to caption
(f) t=0.50t=0.50
Refer to caption
(g) t=0.75t=0.75
Refer to caption
(h) t=1.00t=1.00

SEAM solution

Figure 16: High-fidelity / SEAM solutions of (23) at different time.
High-fidelity model SEAM
Number of FEM d.o.fs (each tnt_{n}) M=29397M=29397 Number of SEAM d.o.fs (each tnt_{n}) p=1p=1
d.o.fs reduction 29397:129397:1
FE solution time 40320s SEAM solution time 8s
SEAM-ErrorL2\text{SEAM-Error}_{L^{2}} 1.2e81.2e{-8}
Table 3: Computational details for the high-fidelity / SEAM solutions of (23).

6 Conclusion

We have studied the singular value distribution of the numerical solution matrix corresponding to a full discretization of second order parabolic equations that uses the backward Euler scheme in time and continuous simplicial finite elements in space. Based on the property that the singular value distribution of the matrix formed by the high-fidelity solution is similar to a rank one matrix under the assumption that the time step size is sufficiently small, we have proposed the SEAM algorithm by choosing the eigenvector associated to the largest singular value as the POD basis. The resulting RB scheme at each time step is a linear equation with only one unknown. Numerical experiments have demonstrated the remarkable efficiency of SEAM.

7 Acknowledgement

This work was supported in part by the National Natural Science Foundation of China (12171340) and National Key R&D Program of China (2020YFA0714000).

References

  • [1] D. Ahlman, F. Söderlund, J. Jackson, A. Kurdila, and W. Shyy, Proper orthogonal decomposition for time-dependent lid-driven cavity flows, Numerical Heat Transfer, Part B: Fundamentals, 42 (2002), pp. 285–306.
  • [2] B. O. Almroth, P. Stern, and F. A. Brogan, Automatic choice of global shape functions in structural analysis, AIAA Journal, 16 (1978), pp. 525–528.
  • [3] N. Aubry, P. Holmes, J. L. Lumley, and E. Stone, The dynamics of coherent structures in the wall region of a turbulent boundary layer, Journal of Fluid Mechanics, 192 (1988), pp. 115–173.
  • [4] A. Barrett and G. Reddien, On the reduced basis method, ZAMM - Journal of Applied Mathematics and Mechanics / Zeitschrift für Angewandte Mathematik und Mechanik, 75 (1995), pp. 543–549.
  • [5] G. Berkooz, Observations on the Proper Orthogonal Decomposition, Springer New York, New York, NY, 1992, pp. 229–247.
  • [6] Y. Cao, J. Zhu, Z. Luo, and I. Navon, Reduced-order modeling of the upper tropical pacific ocean model using proper orthogonal decomposition, Computers & Mathematics with Applications, 52 (2006), pp. 1373–1386.
  • [7] W. Chen, J. S. Hesthaven, B. Junqiang, Y. Qiu, Z. Yang, and Y. Tihao, Greedy nonintrusive reduced order model for fluid dynamics, AIAA Journal, 56 (2018), pp. 4927–4943.
  • [8] D. T. Crommelin and A. J. Majda, Strategies for model reduction: Comparing different optimal bases, Journal of the Atmospheric Sciences, 61 (2004), pp. 2206–2217.
  • [9] J. L. Eftang, D. J. Knezevic, and A. T. Patera, An hp certified reduced basis method for parametrized parabolic partial differential equations, Mathematical and Computer Modelling of Dynamical Systems, 17 (2011), pp. 395–422.
  • [10] J. P. Fink and W. C. Rheinboldt, On the error behavior of the reduced basis technique for nonlinear finite element approximations, Zamm-zeitschrift Fur Angewandte Mathematik Und Mechanik, 63 (1983), pp. 21–28.
  • [11] J. P. Fink and W. C. Rheinboldt, Solution manifolds and submanifolds of parametrized equations and their discretization errors, Numer. Math., 45 (1984), p. 323–343.
  • [12] M. D. Gunzburger, Finite Element Methods for Viscous Incompressible Flows, Computer Science and Scientific Computing, Academic Press, San Diego, 1989.
  • [13] J. Hesthaven and S. Ubbiali, Non-intrusive reduced order modeling of nonlinear problems using neural networks, Journal of Computational Physics, 363 (2018), pp. 55–78.
  • [14] A. Hoffman and H. Wielandt, The variation of the spectrum of a normal matrix, Duke Math. J., 20 (1953), pp. 37–39.
  • [15] P. Holmes, Turbulence, coherent structures, dynamical systems and symmetry, Cambridge University Press, 2012.
  • [16] L. Iapichino, S. Ulbrich, and S. Volkwein, Multiobjective pde-constrained optimization using the reduced-basis method, Advances in Computational Mathematics, 43 (2017), pp. 945–972.
  • [17] K. Ito and S. Ravindran, A reduced basis method for control problems governed by pdes, in Control and estimation of distributed parameter systems, Springer, 1998, pp. 153–168.
  • [18] K. Ito and S. S. Ravindran, A reduced-order method for simulation and control of fluid flows, Journal of computational physics, 143 (1998), pp. 403–425.
  • [19] I. T. Jolliffe, Principal component analysis, Springer, 2011.
  • [20] R. D. Joslin, M. D. Gunzburger, R. A. Nicolaides, G. Erlebacher, and M. Y. Hussaini, Self-contained automated methodology for optimal flow control, AIAA Journal, 35 (1997), pp. 816–824.
  • [21] F. Keinosuke, Introduction to Statistical Pattern Recognition, Academic Press, 2 ed., 1990.
  • [22] Kunisch and Volkwein, Galerkin proper orthogonal decomposition methods for parabolic problems, Numerische Mathematik, 90 (2001), pp. 117–148.
  • [23] Kunisch and Volkwein, Galerkin proper orthogonal decomposition methods for a general equation in fluid dynamics, SIAM Journal on Numerical Analysis, 40 (2002), pp. 492–515.
  • [24] C. Lieberman, K. Willcox, and O. Ghattas, Parameter and state model reduction for large-scale statistical inverse problems, SIAM Journal on Scientific Computing, 32 (2010), pp. 2523–2542.
  • [25] J. Lumley, Transition and Turbulence, Academic Press, 1981.
  • [26] Z. Luo and G. Chen, Proper Orthogonal Decomposition Methods for Partial Differential Equations, Mathematics in Science and Engineering, Academic Press, 2019.
  • [27] Z. Luo, J. Chen, J. Zhu, R. Wang, and I. M. Navon, An optimizing reduced order fds for the tropical pacific ocean reduced gravity model, International Journal for Numerical Methods in Fluids, 55 (2007), pp. 143–161.
  • [28] Z. Luo, R. Wang, and J. Zhu, Finite difference scheme based on proper orthogonal decomposition for the nonstationary navier-stokes equations, Science in China Series A: Mathematics, 50 (2007), pp. 1186–1196.
  • [29] Z. Luo, J. Zhu, R. Wang, and I. Navon, Proper orthogonal decomposition approach and error estimation of mixed finite element methods for the tropical pacific ocean reduced gravity model, Computer Methods in Applied Mechanics and Engineering, 196 (2007), pp. 4184–4195.
  • [30] H. V. Ly and H. T. Tran, Proper orthogonal decomposition for flow calculations and optimal control in a horizontal cvd reactor, Quarterly of Applied Mathematics, 60 (2002), pp. 631–656.
  • [31] Y. Maday, A. T. Patera, J. D. Penn, and M. Yano, A parameterized-background data-weak approach to variational data assimilation: formulation, analysis, and application to acoustics, International Journal for Numerical Methods in Engineering, 102 (2015), pp. 933–965.
  • [32] L. Mainini and K. Willcox, Surrogate modeling approach to support real-time structural assessment and decision making, AIAA Journal, 53 (2015), p. 1612 – 1626. Cited by: 39.
  • [33] A. J. Majda, I. Timofeyev, and E. Vanden-Eijnden, Systematic strategies for stochastic mode reduction in climate, Journal of the Atmospheric Sciences, 60 (2003), pp. 1705–1722.
  • [34] A. Manzoni and S. Pagani, A certified rb method for pde-constrained parametric optimization problems, Communications in Applied and Industrial Mathematics, 10 (2019), pp. 123–152.
  • [35] P. Moin and R. D. Moser, Characteristic-eddy decomposition of turbulence in a channel, Journal of Fluid Mechanics, 200 (1989), pp. 471–509.
  • [36] K. Pearson, Liii. on lines and planes of closest fit to systems of points in space, Philosophical Magazine Series 1, 2, pp. 559–572.
  • [37] J. S. Peterson, The reduced basis method for incompressible viscous flow calculations, SIAM Journal on Scientific and Statistical Computing, 10 (1989), pp. 777–786.
  • [38] C. Prudhomme, D. V. Rovas, K. Veroy, L. Machiels, Y. Maday, A. T. Patera, and G. Turinici, Reliable Real-Time Solution of Parametrized Partial Differential Equations: Reduced-Basis Output Bound Methods , Journal of Fluids Engineering, 124 (2001), pp. 70–80.
  • [39] A. Quarteroni, A. Manzoni, and F. Negri, Reduced Basis Methods for Partial Differential Equations An Introduction, Cham Springer International Publishing, 2016.
  • [40] M. Rajaee, S. K. F. Karlsson, and L. Sirovich, Low-dimensional description of free-shear-flow coherent structures and their dynamical behaviour, Journal of Fluid Mechanics, 258 (1994), pp. 1–29.
  • [41] W. C. Rheinboldt, On the theory and error estimation of the reduced basis method for multi-parameter problems, Nonlinear Analysis-theory Methods & Applications, 21 (1993), pp. 849–858.
  • [42] F. M. Selten, Baroclinic empirical orthogonal functions as basis functions in an atmospheric model, Journal of the Atmospheric Sciences, 54 (1997), pp. 2099–2114.
  • [43] Sirovich and Lawrence, Turbulence and the dynamics of coherent structures. Parts I-III., Quarterly of Applied Mathematics, 45 (1987), pp. 561–590.
  • [44] Sirovich and Lawrence, Turbulence and the dynamics of coherent structures. ii. symmetries and transformations, Quarterly of Applied Mathematics, 45 (1987), pp. 573–582.
  • [45] Sirovich and Lawrence, Turbulence and the dynamics of coherent structures. iii. dynamics and scaling, Quarterly of Applied Mathematics, 45 (1987), pp. 583–590.
  • [46] R. Swischuk, L. Mainini, B. Peherstorfer, and K. Willcox, Projection-based model reduction: Formulations for physics-based machine learning, Computers & Fluids, 179 (2019), pp. 704–717.
  • [47] E. Ulu, R. Zhang, and L. B. Kara, A data-driven investigation and estimation of optimal topologies under variable loading configurations, Computer Methods in Biomechanics and Biomedical Engineering: Imaging & Visualization, 4 (2016), pp. 61–72.
  • [48] K. Veroy, C. Prud’homme, D. Rovas, and A. Patera, A posteriori error bounds for reduced-basis approximation of parametrized noncoercive and nonlinear elliptic partial differential equations, 16th AIAA Computational Fluid Dynamics Conference, (2003).