Abstract

This work aims to evaluate a parallelizable approximate solution model for the wave equation. For that, we used the temporal sweep known as the Waveform Relaxation method to guarantee the parallelization in space. However, this technique has limitations for this class of problems. Therefore, we proposed the combination of the Subdomain method in a non-conventional way in time with the Multigrid method, intending to reduce computational time and improve the convergence factors. In this work, we presented the mathematical analysis of the stability of the discretization model, which uses the Central Finite Difference method with weighting at each time step. As an application of the proposed method, in addition to a problem with a known analytical solution, we solved a wave propagation problem with reflection and phase inversion.

Keywords: Finite difference method, convergence factor, von Neumann criterion

1. Introduction

In this work, we intended to present an efficient and parallelizable method for solving sparse and large systems of equations that result from the discretization of the wave equation, which is a transient Partial Differential Equation (PDE) that models many problems found in several areas of applications. Among these problems are the vibration of strings and membranes, sound waves in gases or liquids, electromagnetic waves, transverse waves in solids, surface ocean waves, among others.

Explicit schemes for obtaining a solution of the wave equation are common in the literature, as in [1,2,3]. In general, such techniques are conditionally stable, which can be a disadvantage when performing refinements in time or space, as some criteria must be accepted for convergence. Another possibility is to use implicit methods, which are commonly unconditionally stable, thus assuring the reliability of the approximate solutions obtained [4].

The wave propagation problem can be studied in two manners, with the Helmholtz equation in the stationary form [5,6,7], or by directly solving the wave equation in the transient form [8,9,10,11]. In this context, we discretized the transient wave equation with the Finite Difference Method (FDM) weighted with a parameter at different time steps [12,13], thus generating an implicit method, which results in a linear system at each time step, which can be solved by using a solver such as Gauss-Seidel, with lexicographical or red-black order.

One way to Speed-up the process of obtaining the system solution resulting from the discretization is to apply the Multigrid method, which significantly improves the convergence factors in the process of solving systems of equations [14,15]. According to Umetani et al. [5] and Franco et al. [16], the anisotropy related to physical and numerical factors generated with large values of ( being associated with wave propagation velocity) may be a challenge in solving the wave equation.

According to Brandt and Livshits [7], there are limitations when attempting to solve the wave equation, even in its stationary form (Helmholtz Equation), because the solver loses efficiency when used in the standard Multigrid method. Therefore, the authors proposed modifications in the numerical experiments so that they would present better convergence rates.

Solutions with high-order compact methods for the wave equation were analyzed by Britt et al. [17], who studied the stability of explicit and implicit methods as well as the effectiveness of the Multigrid and Conjugate Gradients methods. The authors' analysis confirms the Multigrid effectiveness in solving problems with many degrees of freedom.

With the emergence of new technologies and high-performance computing, it became of paramount importance to develop algorithms that can use a large number of cores for data processing, as this greatly increases the efficiency in solving some problems involving PDEs [18].

In that context, a new method was developed: Waveform Relaxation (WR), which is an iterative method proposed to solve large systems of Ordinary Differential Equations (ODEs), but which can be adapted to time-dependent PDEs. In WR, the spatial domain is decomposed by a set of points and for each of these points, a system of ODEs is solved in all time steps [19,20,21,22]. A WR method was developed to solve the poroelasticity problem [23], which is modeled by a system of parabolic PDEs. Other works that apply parallelization are presented in Bellen and Zennaro [24] and Chartier and Philippe [25] for initial value problems and in Keller [26] for boundary value problems.

To non-steady state problems, the WR algorithms differ from the standard time sweep methods (Time-Stepping) in the fact that their iterates are functions in time [21,27]. The Partial Differential Equations is transformed into a large set of Ordinary Differential Equations, and an iterative algorithm can be used to solve this system. This numerical solution needs a high computational effort due to the necessity of solving systems of large dimension at each step point. WR iterations are designed in order to decouple the original large system in smaller subsystems: in this way, the iteration process can be implemented in a parallel computational environment, since each subsystem can be treated by a single processor [28].

In Ruprecht [29], the dispersion relation that occurred in the approximate solution was analyzed by using Parallel-in-Time, which is a time parallelization method used for solving hyperbolic equations. The author investigated propagation and stability characteristics and observed that instability in convergence is mainly caused by adopting medium and high wavenumbers.

Efficient solutions to the one-dimensional wave equation are already found in the literature, as in Baccouch and Temimi [30] for high-order methods and in Erbay et al. [31] for the non-linear cases. However, there are still challenges to be overcome when employing the Multigrid method, especially when combining with schemes that allow parallelization [11]. In this sense, the novelty of this work is the use of the Subdomains in Time method, combined with the Waveform Relaxation strategy and the Multigrid method, in order to reduce the large initial perturbations existing in Gander et al. [11]. Differently from Ong and Mandal [32], we work with a reduced number of subdomains in time, with the aim of reducing the CPU time and at the same time increase the degree of parallelization of the codes used.

The present work is organized as follows: In Section 2, we present the mathematical and numerical models adopted for the implicit discretization of the wave equation, as well as the stability of the numerical model and a foundation for the Multigrid method. In Section 3, we cover the details of the WR and Subdomain methods. In Section 4, we expose the results of simulations and comparisons between conventional WR and the method proposed in this paper. In Section 5, we present an application to the wave propagation problem with reflection, and finally, in Section 6, we present the conclusions.

2. Mathematical and numerical models

2.1 One-dimensional wave equation

Given a positive scalar , such that , where is related to the linear density and the stress in a string (wave propagation velocity), we present the one-dimensional wave equation [33], as

(1)

(2)

(3)

(4)

where is the displacement at position and time , is the initial configuration, is the initial velocity, is the string length, and finally, and are the boundary conditions. This set of equations models a problem of vibration of a string fixed at the ends, in which the general solution is built with the fundamental frequencies of vibration, which are given by

(5)

where,

(6)
(7)
(8)
(9)

2.2 Discretization

Spatial and temporal discretizations are performed by using the Finite Difference Method (FDM), where the approximation process starts with the representation of the continuous domain by a discrete domain, which consists of an ordered set of points that form the grid [4]. In this way, it is possible to use a Taylor series expansion to represent an analytic function in the neighborhood of and thus obtain an approximation for the second derivative of given by

(10)

with a truncation error

(11)

Assuming the problem defined by Eqs. (1) to (4), we define the size of the spatial interval and the increment in time , with the number of spatial points and temporal points , for the final time . Assuming as an approximation for the solution at coordinate point and time step , we can write Eq. (1) in the discretized form, applying weighting in the spaces [12], given by

(12)

where is a weighting parameter. The Figure 1 illustrates the points used to calculate , with spatial coordinate , at a certain time step .

Space-time discretization scheme for the 1D grid.
Figure 1. Space-time discretization scheme for the 1D grid

By reordering the terms of Eq. (12), we obtain

(13)

with a truncation error of the order , given by

(14)

Assuming that (herein called anisotropy factor), we have the following system of equations

(15)

where,

(16)
(17)
(18)

To perform the first iteration, it is necessary to know the solution in two previous time steps and . To start the process, is given by the initial setup while is given in Burden and Faires [4], by

(19)

2.3 Stability

Next, we will use the Von Neumann criterion [34] to determine the stability of the discretization method described in section 2.2. For that, let us assume that the global error is given by a Fourier series of local errors, also called harmonics. So, the error in the first time step can be expressed as:

(20)

with . Note that we have a system with equations and unknowns, where the coefficient matrix is non-singular [12]. Now let us assume that a generic harmonic can be written in the form

(21)

where and , both being arbitrary. Consequently, to analyze the stability of the discretization method, it is enough to verify the propagation of this harmonic as increases. By substituting Eq. (21) into Eq. (13), with [12,13], we have

(22)

or yet,

(23)


By dividing both sides of Eq. (23) by and rearranging the terms, we have

(24)

Using Euler's formula, , we can rewrite Eq. (24) as

(25)

or yet,

(26)

Using the trigonometric identities and , Eq. (26) can be rewritten as

(27)

or yet,

(28)

From Eq. (21) we have that , that is, is the amplification factor. Let us look at what happens to the generic harmonic as increases. From Eq. (28) we know that , and , so it is enough to analyze the following cases:


1) , which implies that . In this case, the anisotropy factor must be analyzed in the following situations:

1.1) , which implies . Note that in this case the harmonic tends to stay the same as increases, but it will not be amplified.

1.2) , which implies . Note that in this case has a decreasing amplitude.

2) , regardless of the value of , we will have , which also produces a decreasing amplitude for .


Given the above, the harmonics will not be amplified, since . Therefore, the discretization method used in Eq. (13) with is unconditionally stable.

2.4 Multigrid method

In some cases, when discretizing PDEs that model physical problems, we can obtain sparse and large linear systems, as described by Eq. (15), which can be rewritten as

(29)

These systems can be solved by using direct or iterative methods (herein called solvers). Due to the characteristics of these systems, the direct methods become unfeasible due to the high computational cost [4]. In this case, we opt for iterative methods. However, these methods generally have good smoothing properties only at the beginning of the iterative process.

After a few iterations, the approximation error becomes smooth, but not necessarily small. This problem is due to the characteristic of classical iterative methods in quickly smoothing out high-frequency errors (oscillatory modes), leaving only low-frequency errors (smooth modes) [35].

In this context, the Multigrid method [36] can be applied. It is used for accelerating the convergence in obtaining the solution of this type of system, since when using a set of grids, it is possible to smooth both the oscillatory and smooth modes, as the smooth modes in fine grids become more oscillatory in coarser grids [14,37]. This approach allows the iterative process of the Multigrid method to act on all error components [38,39,40,41].

The way it runs through the different grid levels is called a cycle [42]. In this work, we used the V-cycle, shown below in Figure 2, where there is an example of a V-cycle for 5 levels of coarsening; from fine grid to the desired or coarsest grid . Note that we use the coarsening ratio , with being the spacing in the fine grid and the spacing in the immediately coarser grid.

Multigrid V-cycle.
Figure 2. Multigrid V-cycle

In this cycle, the system of equations is smoothed times (pre-smoothing) in the fine grid, and then we restrict its residue to the immediately coarser grid with the restriction operators (). In this work, we used the full weighting operator, given by

(30)

where and are, respectively, the residue in the fine and coarse grid. This process is repeated until the coarsest grid is reached and only then the problem is solved

Next, the prolongation of corrections is performed by using the linear interpolation operator (), given by

(31)

where the first equation is for even and the other is for odd , in the . The solution is then corrected and the system of equations is smoothed times (post-smoothing), and the process is repeated until the finer grid is reached, where the solution is smoothed times [39]. The V-cycle is repeated until the stopping criterion is met. This approach allows the iterative process of the Multigrid method to smooth all the components [43].

3. Waveform relaxation and the subdomain methods

Waveform Relaxation (WR) is an iterative method that was initially proposed to solve large systems of Ordinary Differential Equations (ODEs) [19], but it can also be applied in time-dependent PDEs, where the spatial domain is decomposed by a set of points, and for each of them a system of ODEs is solved in all time steps [22,23,44,45]. This method allows the parallelization of algorithms for transient PDEs to be performed. According to [46], the feature of the WR method that transforms PDEs into an ODE system presents the form

(32)

where are vectors or functions that contain temporal information for each spatial coordinate , and which is calculated with the values of . Thus, for each node of the spatial discretization, a temporal ODE is solved to the final time independently. Each component of the system given in Eq. (32) can be written as an ODE, as follows

(33)

where is the dimension of the system and the notations and with indicate respectively, the initial configurations and velocities, for each point of the spatial discretization. Each line of the system of Eqs. (33) can be solved separately using a core for each line, as illustrated in Figure 3 for .

Waveform Relaxation method.
Figure 3. Waveform Relaxation method


Each temporal ODE can be solved in all spatial nodes separately, where the update of unknowns can be performed at the end of a WR cycle. Thus, we have an iterative method of repeating the procedure until a stopping criterion is reached [47]. We can obtain a fully parallelizable method in space by using a colored ordering scheme in the solver, such as Gauss-Seidel Red-Black (GSRB) [45].

It is possible to combine Waveform Relaxation and the Multigrid method when performing coarsening only in the spatial direction because WR is continuous in time. This way, the number of temporal discretization points is kept constant [45]. For example, for a fine grid with points, the coarser grids, with a coarsening ratio , are , , and , which respectively have , , and points. Then, a Multigrid cycle is performed at all spatial points for all time steps. In Algorithm 1, the structure of the Waveform Relaxation and Multigrid is presented for the solution of system , adapted from [23].}

Algorithm 1. Waveform Relaxation with Multigrid (WRMG):
if we are on the coarsest grid-level (with spatial grid-size given by ) then
Solve with a direct or fast solver.
else
Pre-smoothing: steps of the GSRB Waveform Relaxation.
Compute the defect.
Restrict the defect.
Solve the defect equation by performingone V-cycle of WRMG.
Interpolate the correction.
Compute a new approximation.
Post-smoothing: steps of the GSRB Waveform Relaxation.
end if


In Gander et al. [11] there is a variation of the Waveform Relaxation method, which can be applied to PDEs, where the domain is divided into spatial subdomains. Remember that each point is solved independently and continuously until the final time, which generates a parallelizable strategy. See Figure 4 for .

Division of the domain Ω into K=3 spatial subdomains.
Figure 4. Division of the domain into spatial subdomains


We can notice that in the case where the subdomains are the smallest possible, the subdomains are respectively equal to the points . That is, we will have the standard Waveform Relaxation method. Note that parallelization can be performed by using a processing core for each spatial subdomain.

In Gander et al. [11] and Gong et al. [48] a study is carried out to assess the stability of using this approach for heat and Helmholtz equations, as well as the ways of exchanging information between the subdomains. The authors also mention that at the beginning of the iterative process, the convergence is negatively affected, and perturbations may occur in the approximate solution, but as the iterative process advances, the solution converges to the desired values. See Figure 5, taken from Gander et al. [11].

Error for the heat equation with Waveform Relaxation by spatial subdomains [11].
Figure 5. Error for the heat equation with Waveform Relaxation by spatial subdomains [11]


In this case, Gander et al. [11] shows the convergence for the one-dimensional heat transfer problem with the method called Dirichlet-Neumann Waveform Relaxation. In the left figure, the author presents the theoretical error (error) and the numerical error (bound) obtained with five fixed spatial subdomains and different final times (, as used in the figure). In the right figure, the number of subdomains varies, and the final time is fixed at s. We can notice that the initial oscillations are higher when the final time is higher and/or there are more subdomains in space. Here we have a great challenge: the higher the number of subdomains, the higher the degree of parallelization; however, the oscillations at the beginning of the iterative process will be also higher.

Another approach is proposed in Ong and Mandal [32], where, besides the division in spatial subdomains, there is also a division in temporal subdomains, thus generating an approach that is highly parallelizable (see Figure 6 for and ).

Waveform Relaxation method by K = 3 spatial and J = 2 temporal subdomains.
Figure 6. Waveform Relaxation method by spatial and temporal subdomains


Notice that the approach proposed in Gander et al. [11] is a specific case of the approach presented in Ong and Mandal [32], which adopts . In this work, we propose a thorough analysis of the second methodology, which adopts the minimum number of spatial subdomains () and a reduced number of temporal subdomains, to solve the wave equation with the WR method, aiming to reduce the oscillations at the beginning of the iterative process. For this, we analyze the effect of parameters such as time and space interval, physical properties of the wave, number of temporal subdomains, among others. This method is applied using recursively the Algorithm 1 according to Figure 7.

Efficient solutions to the one-dimensional wave equation are already found in the literature, such as in Baccouch and Temimi [30] for high-order methods and in [31] for nonlinear cases. However, there are still challenges to solve when using the Multigrid method, especially when combined with schemes that allow parallelization, as in Gander et al. [11]. In this sense, one of the novelties of this work focuses on the use of the Subdomains in Time method, combined with the Waveform Relaxation strategy and the Multigrid method, in order to reduce the existing large initial oscillations. Unlike the Ong and Mandal [32], here we work with a reduced number of subdomains in time, in order to reduce CPU time while increasing the degree of parallelization of the codes used.

Waveform Relaxation with Subdomain method.
Figure 7. Waveform relaxation with subdomain method

4 Results

In this section, we present the main results of this work, where we solve a one-dimensional problem with Dirichlet boundary conditions, Eqs. (1) to (4), which serves to validate the proposed methodology. We approach techniques of code verification based on the errors of the numerical simulations and on a posteriori analyses of the results found with the Multigrid (with V-cicle(2,2)) and Singlegrid formulations. In our analyses, we use the Gauss-Seidel solver with Red-Black ordering. Then, we discuss the characteristics of the application of the standard Waveform Relaxation method in the one-dimensional wave equation and some problems regarding the use of this formulation. To deal with these problems, we apply the Subdomain Method proposed by Ong and Mandal [32]. We innovate by assuming a fixed parameter with variation only in . Finally, we analyze the convergence factors, complexity order (with a non-linear adjustment), CPU time, and Speed-ups.

The one-dimensional wave propagation problem modeled by Eqs. (1) to (4) is solved by admitting , with initial condition and initial velocity . We adopt the same number of points in the spatial and time discretization (denoted by ), weighting parameter , final time and . Tests were performed in a computer with Intel Corei3 1.5 GHz processor, 4 GB RAM, and 64-bits Windows 10 operational system with double precision.

4.1 Discretization error

The discretization error is related to the truncation in the Taylor series [4] and consequently, to the size of the grid elements. For the sake of assessing the behavior of this type of error, we disregard iteration and round-off errors. For this, each problem was solved until the round-off error was reached. Next, we present in Figure 8 the infinity norm of the error in the solution approximated with the Waveform Relaxation (WR), combined with the Multigrid (MG) and Singlegrid (SG) for values of .

Infinity norm of the discretization error for different grid sizes with the Waveform Relaxation method.
Figure 8. Infinity norm of the discretization error for different grid sizes with the Waveform Relaxation method


We noticed that the discretization error decreases as the grid is refined. The errors presented in Figure 8 are the same found in Malacarne et al. [13] using the Time-Stepping method, which generates a 4th-order method, which can be easily verified using the methodology present in da Silva et al. [49]. This test serves to verify the code used here, which utilizes time sweeping given by WR.

4.2 Oscillations in the approximate solution

Next, we show the oscillatory behavior of the solution during the iteration process, when using the Waveform Relaxation method. For such, we solve a one-dimensional problem modeled by Eqs. (1) to (4), using Singlegrid (SG) and Gauss-Seidel with Red-Black ordering as the solver, in a grid with points. Figure 9 presents the solutions for and iterations, and Figure 10 shows the solutions for and iteration, both using final time .

Draft Malacarne 871275788-sol 2 it SG WR 2.png Draft Malacarne 871275788-sol 50 it SG WR 2.png
Figure 9. Solution with 2 (left) and 50 iterations (right)


Draft Malacarne 871275788-sol 600 it SG WR 2.png Solution with 200 (left) and 1000 iterations (right).
Figure 10. Solution with 200 (left) and 1000 iterations (right)


We verified significant initial oscillations when applying the standard WR method, even when using coarser grids (with fewer points). Despite the strong oscillation at the beginning of the process, the numerical solution converges to the desired values as a large number of iterations are performed.

In Figure 11 it is possible to observe the behavior of the infinity norm of the residue as the iterations are performed, for Singlegrid and Multigrid.

Residue versus iterations for Singlegrid and Multigrid.
Figure 11. Residue versus iterations for singlegrid and multigrid


Even though MG performs fewer cycles than SG, the order of perturbation of the residue of both is the same. This initial perturbation is not a desirable characteristic in the approximation process and despite being well-known in the literature, its causes remain an unknown [11] and negatively interfere in the convergence factors and in the CPU time.

In Figure 12, we present the infinity norms of the residues for different numbers of points, with final time fixed at (left), and then varying the final time , with (right), using SG and standard WR.

Draft Malacarne 871275788-res 1D SG 01.png Residue versus iterations varying N, with tf= 1.0s  (left), and varying tf, with N=2⁷+1 (right).
Figure 12. Residue versus iterations varying , with (left), and varying , with (right)


Notice that with the increase in the final time, the maximum residue increases considerably, at the order of , similarly to what happens when the number of points in the grid increases. This implies a loss of efficiency when solving problems with WR and Singlegrid with many degrees of freedom and/or a final time relatively large. Very similar residues are found when applying the Multigrid method for these cases, as seen in Figure 11.

4.3 Average convergence factor - Standard waveform relaxation

Here we apply the standard Waveform Relaxation method for the problem described in the previous section, but with varying final time. For this, let the convergence factor be , with being the residue generated in the iteration . We know that results in more efficient methods, while means the opposite [50]. We also define the average convergence factor [39], by

(34)

According to Thole and Trottenberg [51] and Horton and Vandewalle [52] can be considered as a measure of the anisotropy level in the discretized operator in a given grid, and such anisotropy can affect the performance of the solver. As depends on the temporal and spatial increments adopted in the discretization and on the velocity of the propagation of the wave, thus represents a measure of physical and geometrical anisotropy of the wave equation.

We can write the final time depending directly on and , with the expression . Then, we present the test results, where we vary the value of the parameter and calculate for a wide range of problems, which covers the vast majority of real cases of wave propagation. In order to verify the behavior of the standard Waveform Relaxation method, using the Singlegrid and Multigrid Methods (Figure 13).

Malacarne et al 2022a 9117 Fig13.png
Figure 13. versus with standard Waveform Relaxation using Multigrid and Singlegrid


We can observe in Figure 13, that as increases, the average convergence factors of the Multigrid and Singlegrid Methods also increase, becoming , which is not good. With this, we can conclude that the solution model is neither efficient nor robust for intermediate or large values (in this cases we have many unkwows and longer final times). This result supports the hypothesis that it is inefficient to apply the standard Waveform Relaxation method to solve the wave equation, whether with the Multigrid or Singlegrid methods.

The hyperbolic transient wave computational simulation problem can be solved in different ways, but most of them have limitations, especially for relatively large end times. For these cases, explicit schemes exhibit instabilities that compromise the reliability of the approximate solution [53]. As we have seen, even implicit methods present difficulties to solve these cases, because at the beginning of the iterative process, the approximate solutions present strong oscillations, which are smoothed out as the number of iterations increases (Figures 9 and 10), but this seriously compromises the efficiency of such methods. Therefore, we seek to improve the applicability of parallelizable methods, such as the Waveform Relaxation Method. For this, we combine the methodology developed so far with the Subdomains in Time method.

4.4 Applying the subdomain method

From this section on, we present the results of the Waveform Relaxation Method combined with the Subdomain in Time method. For this, we will always adopt for the number of spatial subdomains. For the number of subdomains in time, we will always adopt the smallest possible value, but one that is able to provide good average convergence factors (). Next in Table 1 are the values used for , which may vary depending on the values of and . The choice of was based on empirical analysis of this data so that , ie, so that the implicit numerical model can be considered acceptable [39].

Table 1. Number of subdomain in time according to the ranging of and
-
1 1 1 1 1 1 1 1 1 1
1 1 1 1 2 2 2 2 2 2
1 1 1 2 2 2 2 2 2 2
1 1 2 4 4 4 4 4 4 4
1 1 2 4 8 8 8 8 8 8
1 2 8 16 16 16 16 16 16 16


We should also note that, for large , the number of spatial meshes within each temporal subdomain will be small, which may reduce the level of parallelization of the method. Thus, it is always interesting to have the smallest possible value for , but in the case of , we have the standard Waveform Relaxation method, which we already know is not efficient. We point out that all the following tests were performed using the number of subdomains in time that are present in the Table 1.

It is also possible to notice that for domains with small , the largest number of subdomains in time is , regardless of the value of . But for problems with large , depending on the value of , we cannot work with a very small number for , because the instabilities of the standard Waveform Relaxation will negatively affect the values of .

To solve the problem of higher residues during the initial iterations, we analyzed the method parameters as proposed by Ong and Mandal [32], with the goal to improve the average convergence factors. We kept the number of spatial subdomains fixed at and analyzed the number of temporal subdomains . This way, we obtained a highly parallelizable strategy when using the Waveform Relaxation method. Figure 14 shows the behavior of the residue, using SG and WR for that is, a total of points, with .

Draft Malacarne 871275788-res 1D SG 257 a.png Residues versus iterations for tf= 1.0s , N=2⁸+1  and K=1, with J=1 (left) and J=4 (right).
Figure 14. Residues versus iterations for , and , with (left) and (right)


By solving the wave equation with SG and WR using only one temporal subdomain (), we have the , with a maximum residue of the order of . However, by using four temporal subdomains (), where the subdomain values vary from to , from to , from to , and from to , we have the maximum residue of the order of and the processing time is reduced to .

In Figure 15 we can observe the behavior of the order of the maximum residue concerning the number of temporal subdomains , as well as the values of , considering .

Malacarne et al 2022a 3354 Fig15.png
Figure 15. Residue versus , for and , varying , with SG and WR


We verified that the largest reductions in the residue are found in the first subdivisions of the domain. For instance, for and , the maximum residue has an order of and , however, when using Subdomain Method, this residue decreases to an order of and . We further highlight the considerable improvement in the order of residue and computational time.

4.5 Average convergence factor - Waveform relaxation with subdomain in time

Next, Figure 16 presents the average convergence factors for the Multigrid and Singlegrid methods with different values of for different values of , combined with the Waveform Relaxation method, where the choice of the appropriate number of subdomains was made based on Table 1.

Malacarne et al 2022a 9865 Fig16.png
Figure 16. for the Multigrid and Singlegrid methods, combined with Waveform Relaxation Relaxation,
and suitable


In this case, we used the same number of subdomains for the MG and SG. We found out that both methods present , for values of , which implies high efficiency. But, as increases, the SG shows values of with the refinement of the grid, that is, the method is inefficient in this region. In the same region, the MG shows values of with the refinement of the grid. In the worst case, in the region near , the MG presents , though it still shows lower convergence factors than those presented by the SG method.

Therefore, the MG method proposed for the wave equation is much more efficient for these values of . Besides, we notice that the values of tend to not depend on the value of for finer grids, which evidences the robustness of the method. In this work, high values of can mean higher final times or wavenumbers , or even, highly refined spatial grids.

An example can be given for the case , with , temporal subdomains and spatial subdomain. For the SG method, we have , with and a total of iterations. For the MG method, we have , , and a total of 23 V-cycles, which confirms the advantage of employing the MG combined with the Subdomain technique for the WR proposed in this work, that is, temporal subdomains and spatial subdomain . A possible explanation for this advantage can be found in the reduction of the average convergence factor of the MG method with the increase in the number of temporal subdomains (), as seen in Figure 17.

Malacarne et al 2022a 3213 Fig17.png
Figure 17. for the MG and SG methods with Waveform Relaxation and different numbers of temporal subdomains
and , with

4.6 Order of complexity

We made a geometrical adjustment [4] to verify the complexity of the algorithm that uses WR combined with subdomains and compared the results for Single and Multigrid. For this, we used the following expression

(35)

where is the coefficient of the method, represents the order of complexity of the solver related to the slope of the adjustment curve and is the total number of variables of the problem, which in our case will be . Theoretically, must be near for the Multigrid method [14]. Table 2 shows the results for these parameters, with different values of . To find the values of , we kept fixed and varied the final time.

Table 2. Geometrical adjustment parameters for the 1D wave equation
3.00E-04 0.6997 2.00E-04 0.7101
2.00E-04 0.8943 4.00E-04 0.7822
9.00E-05 1.2051 1.00E-04 1.0319
6.00E-05 1.6515 8.00E-05 1.0833
2.00E-06 1.8277 3.00E-04 0.8955
2.00E-06 1.8188 1.00E-04 0.9898


As the values of increase, the tends to values near and the near . This trend confirms the linear behavior of the Multigrid method and highlights the disadvantage of using the Singlegrid method for large values of , which corroborates the results depicted in Figures 16 and 17.

4.7 Speed-up

In this section, we analyze the Speed-up, which is given by the ratio between the computational time of the SG and the MG. Figure 18 shows the Speed-up results for increasing number of points of the problem (), for different values of , considering and .

Malacarne et al 2022a 9115 Fig18.png
Figure 18. Speed-up versus for different values of , and


Notice that the Speed-up increases along with the increase in the number of points (desirable property) and also for higher values of . For example, when , with and temporal subdomain , the MG method has a and the SG a . That is, the MG method solves the problem roughly times faster than the SG method.

5. Application: Wave propagation problem with reflection

Here we approach a more realistic problem that is solved by approximation. We admit , , , initial configuration and velocity , , that is, we have a straight string in rest position in the initial time, fixed at both ends. Time can be divided in the intervals , where the is the time in which the oscillation reaches the maximum displacement. Then, we apply a pulse in the extremity , between the interval . This pulse can be inserted into the problem, given by the following boundary conditions

(36)

In this work, we adopt , , , and . One can verify the propagation of the pulse as time varies on Figure 19.

Draft Malacarne 871275788-reflex 00.png Draft Malacarne 871275788-reflex 01.png
Draft Malacarne 871275788-reflex 02.png Draft Malacarne 871275788-reflex 03.png
Draft Malacarne 871275788-reflex 04.png Draft Malacarne 871275788-reflex 05.png
Draft Malacarne 871275788-reflex 06.png Propagation of pulse on a string as time advances.
Figure 19. Propagation of pulse on a string as time advances


By observing Figure 19, from left to right and from top to bottom, we can verify the phenomenon of wave propagation on a string, where there is an inversion of the phase in which the pulse was applied. We solve this problem by applying the WR method with (standard) and WR with temporal subdomains , combined with the SG and MG for both cases. Table 3 shows some of the parameters assessed.

Table 3. Parameters of the solution with standard WR () and with WR with temporal subdomains ,
for wave propagation with reflection and phase inversion
2.94E-01 1.67E-01 1.23E-01 6.59E-02
9.51E-01 7.38E-01 8.72E-01 2.35E-02
1.03E+12 1.03E+12 5.67E+01 5.67E+01


By using , the analyzed parameters improve significantly, especially the average convergence factor combined with MG, thus proving the efficiency of this applied method for the wave equation.

6. Comments

The methodology presented here, can be extended also to more realistic problems, by considering the external forces operating on the problem, by inserting in the right hand side of Eq. (1), because according to Trottenberg et al. [14] causes changes only source term of the system of equations, not changing the performance of the method. Another possibility is to check the applicability of the Waveform Relaxation method with Subdomains in Time to two-dimensional and three-dimensional problems. As well as the application of the Multigrid method, which as seen in this article, can signifcantly decrease the average convergence factors, making it possible to obtain powerful parallelizable methods.

7. Conclusions

In this work, we presented a scheme of parallelizable solutions for the one-dimensional wave propagation problem that uses discretization combined with the Finite Difference Method, weighted by a parameter in different stages of time. The innovation can be seen in the application of the Waveform Relaxation method with temporal subdomains and only one spatial subdomain, in which we were able to significantly reduce the order of the maximum residue. We also innovated when applying the Multigrid method for this class of problems and we showed a considerable improvement in the processing time and convergence factors, in codes that allow parallelization, mainly when working with large values of . Moreover, we applied this technique to analyze the solution of a problem of pulse propagation on a string, thus proving the efficiency of the proposed method.

We also point out that the main challenge of using the Waveform Relaxation method for the wave equation is in the initial increase of the residual, since this negatively alters all the parameters analyzed, and that it was already known in the literature [11]. We emphasize that this problem was solved satisfactorily with the methodology presented in this work.

Disclosure statement: No potential conflict of interest was reported by the authors.

Funding: This study was financed in part by the Coordenco de Aperfeicoamento de Pessoal de Nível Superior (CAPES), Finance Code 88882.381810/2019-01.

References

[1] Weber I., Kreiss G., Nazarov M. Stability analysis of high order methods for the wave equation, Journal of Computational and Applied Mathematics, 404:113900, 2022.

[2] Gander M.J., Halpern L., Nataf F. Optimal Schwarz waveform relaxation for the one dimensional wave equation. SIAM Journal on Numerical Analysis, 41(5):1643&-1681, 2003.

[3] Bamberger A., Glowinski R., Tran Q.H. A domain decomposition method for the acoustic wave equation with discontinuous coefficients and grid change. SIAM Journal on Numerical Analysis, 34(2):603-639, 1997.

[4] Burden R., Faires J.D. Numerical analysis. Brooks/Cole Cengage Learning, pp. 882, 2016.

[5] Umetani N., MacLachlan S.P., Oosterlee C.W. A multigrid-based shifted Laplacian preconditioner for a fourth-order Helmholtz discretization. Numerical Linear Algebra with Applications, 16(8):603–626, 2009.

[6] Ernst O.G., Gander M.J. Multigrid methods for Helmholtz problems: a convergent scheme in 1D using standard components. Direct and Inverse Problems in Wave Propagation and Applications, De Gruyer (Ed.), 135-186, 2013.

[7] Brandt A., Livshits I. Wave-ray multigrid method for standing wave equations. Electronic Transactions on Numerical Analysis, 6:162-181, Kent State Univesity, 1997.

[8] Dehghan M., Mohebbi A. The combination of collocation, finite difference, and multigrid methods for solution of the two-dimensional wave equation. Numerical Methods for Partial Differential Equations: An International Journal, 24(3):897–910, 2008.

[9] Malacarne M.F., Pinto M.A.V., Franco S.R. Computational simulation of one-dimensional waves with the Multigrid Method. Brazilian Journal of Development, 7(8):83763–83775, 2021.

[10] Gander M.J., Halpern L., Rannou J., Ryan J. A direct time parallel solver by diagonalization for the wave equation. SIAM Journal on Scientific Computing, 41(1):A220–A245, 2019.

[11] Gander M.J., Kwok F., Mandal B.C. Dirichlet–Neumann waveform relaxation methods for parabolic and hyperbolic problems in multiple subdomains. BIT Numerical Mathematics, 173–207, Springer, 2021.

[12] Cuminato J.A., Meneguette M. Discretization of partial differential equations: finite difference techniques (in Portuguese). Brazilian Mathematical Society, 2013.

[13] Malacarne M.F., Pinto M.A.V., Franco S.R. Performance of the multigrid method with time-stepping to solve 1D and 2D wave equations. International Journal for Computational Methods in Engineering Science and Mechanics, 23(1):45–56, Taylor & Francis, 2022.

[14] Trottenberg U., Oosterlee C.W., Schuller A. Multigrid. Elsevier, pp. 631, 2000.

[15] Wienands R., Oosterlee C.W. On three-grid Fourier analysis for multigrid. SIAM Journal on Scientific Computing, 23(2):651–671, 2001.

[16] Franco S.R., Gaspar F.J., Pinto M.A.V., Rodrigo C. Multigrid method based on a space-time approach with standard coarsening for parabolic problems. Applied Mathematics and Computation, 317:25–34, 2018.

[17] Britt S., Turkel E., Tsynkov S. A high order compact time/space finite difference scheme for the wave equation with variable speed of sound. Journal of Scientific Computing, 76(2):777–811, 2018.

[18] Gander M.J., Neumuller M. Analysis of a new space-time parallel multigrid algorithm for parabolic problems. SIAM Journal on Scientific Computing, 38(4):A2173–A2208, 2016.

[19] Lelarasmee E., Ruehli A.E., Vincentelli S.A.L. The waveform relaxation method for time domain analysis of large scale integrated circuits theory and apllications. IEEE Trans. Comput. Aided Design Integr. Circ. Systems, 1(3):131-145, 1982.

[20] Lubich Ch., Ostermann A. Multi-grid dynamic iteration for parabolic equations. BIT Numerical Mathematics, 27(2):216–234, 1987.

[21] Vandewalle S., Horton G. Multicomputer-multigrid solution of parabolic partial differential equations. Multigrid Methods IV: Proceedings of the Fourth European Multigrid Conference, Springer Basel AG, Vol. 116, pp. 97-109, 1993.

[22] Gander M.J. Overlapping Schwarz for linear and nonlinear parabolic problems. 9th International Conference on Domain Decomposition Methods, pp. 97–104, 1996.

[23] Franco S.R., Rodrigo C., Gaspar F.J., Pinto M.A.V. A multigrid waveform relaxation method for solving the poroelasticity equations. Computational and Applied Mathematics, 37(4):4805–4820, 2018.

[24] Bellen A., Zennaro M. Parallel algorithms for initial-value problems for difference and differential equations. Journal of Computational and applied mathematics, 25(3):341–350, 1989.

[25] Chartier P., Philippe B. A parallel shooting technique for solving dissipative ODE's. Computing, 51(3-4):209–236, 1993.

[26] Keller H.B. Numerical methods for two-point boundary-value problems. Courier Dover Publications, pp. 397, 1992.

[27] Gander M.J. 50 years of time parallel time integration. Springer International Publishing, 69-113, 2015.

[28] Conte D., D'Ambrosio R., Paternoster B. GPU-acceleration of waveform relaxation methods for large differential systems. Numerical Algorithms, 71(2):293–310, 2016.

[29] Ruprecht D. Wave propagation characteristics of Parareal. Computing and Visualization in Science, 19(1-2):1–17, 2018.

[30] Baccouch M., Temimi H. A high-order space–time ultra-weak discontinuous Galerkin method for the second-order wave equation in one space dimension. Journal of Computational and Applied Mathematics, 389:113331, 2021.

[31] Erbay H.A., Erbay S., Erkip A. A semi-discrete numerical method for convolution-type unidirectional wave equations. Journal of Computational and Applied Mathematics, 387:112496, 2021.

[32] Ong B.W, Mandal B.C. Pipeline implementations of Neumann–Neumann and Dirichlet–Neumann waveform relaxation methods. Springer. Numerical Algorithms, 78(1):1–20, 2018.

[33] Olver P.J. Introduction to partial differential equations. Undergraduate Texts in Mathematics, Springer, pp. 651, 2014.

[34] Thomas J.W. Numerical partial differential equations: finite difference methods. Texts in Applied Mathematics, Vol. 22, Springer Science & Business Media, 2013.

[35] Wesseling P. Introduction to multigrid methods. NASA ICASE, Final Report, 1995.

[36] Brandt A., Livshits I. Multi-level adaptive solutions to boundary-value problems. Mathematics of Computation, 31(138):333-390, 1977.

[37] Brandt A., Livne O.E. Multigrid techniques: 1984 guide with applications to fluid dynamics. SIAM, Classics in Applied Mathematics, Series Number 67, pp. 230, 2011.

[38] Elman H.C., Ernst O.G., O'leary D.P. A multigrid method enhanced by Krylov subspace iteration for discrete Helmholtz equations. SIAM Journal on Scientific Computing, 23(4):1291–1315, 2001.

[39] Trottenberg U., Clees T. Multigrid software for industrial applications-from MG00 to SAMG. 100 Volumes of ‘Notes on Numerical Fluid Mechanics’, Springer, pp. 423–436, 2009.

[40] Rutz G.V., Pinto M.A.V., Gonçalves S.F.T. On the robustness of the multigrid method combining ILU and Partial Weight applied in an orthotropic diffusion problem. Revista Internacional de Métodos Numéricos para Cálculo y Diseño en Ingeniería, 35(1), 23, 2019.

[41] Anunciação M.A.M., Pinto M.A.V., Neundorf R.L.A. Solution of the Navier-Stokes equations using projection method and preconditioned conjugated gradient with multigrid and ilu solver. Revista Internacional de Métodos Numéricos para Cálculo y Diseño en Ingeniería, 36(1), 17, 2020.

[42] Laís de Oliveira M., Pinto M.A.V., Gonçalves S.F.T., Rutz G.V. On the robustness of the xy-zebra-gauss-seidel smoother on an anisotropic diffusion problem. Tech Science Press. Computer Modeling in Engineering & Sciences, 117(2):251–270, 2018.

[43] Falgout R.D., Friedhoff S., Kolev T.V., MacLachlan S.P., Schroder J.B., Vandewalle S. Multigrid methods with space–time concurrency. Computing and Visualization in Science, 18(4-5):123–143, 2017.

[44] Liu J., Jiang Y.-J. Waveform relaxation for reaction–diffusion equations. Journal of Computational and Applied Mathematics, 235(17):5040-5055, 2011.

[45] Vandewalle S. Parallel multigrid waveform relaxation for parabolic problems. Teubner Skripten zur Numerik, Springer-Verlag, pp. 247, 2013.

[46] Vandewalle S., Horton G. Fourier mode analysis of the multigrid waveform relaxation and time-parallel multigrid methods. Computing, 54:317-330, 1995.

[47] Crow M.L., Ilic M. The parallel implementation of the waveform relaxation method for transient stability simulations. IEEE Transactions on Power Systems, 5(3):922–932, 1990.

[48] Gong S., Gander M.J., Graham I.G., Lafontaine D., Spence E.A. Convergence of parallel overlapping domain decomposition methods for the Helmholtz equation. Numerical Mathematics, 152:259–306, 2022.

[49] da Silva L.P., Rutyna B.B., Righi A.R.S., Pinto M.A.V. High order of accuracy for Poisson equation obtained by grouping of repeated Richardson extrapolation with fourth order schemes. Computer Modeling in Eengineering & Sciences, 128(2):699–715, 2021.

[50] Briggs W.L., Henson V.E., McCormick S.F. A multigrid tutorial. SIAM, Other Titles in Applied Mathematics, 2nd Edition, pp. 193, 2000.

[51] Thole C.-A., Trottenberg U. Basic smoothing procedures for the multigrid treatment of elliptic 3D operators. Applied Mathematics and Computation, 19(1-4):333–345, 1986.

[52] Horton Gr., Vandewalle S. A space-time multigrid method for parabolic partial differential equations. SIAM Journal on Scientific Computing, 16(4):848–864, 1995.

[53] Bailly C., Juve . Numerical solution of acoustic propagation problems using linearized Euler equations. AIAA Journal, 38(1):22–29, 2000.
Back to Top

Document information

Published on 08/11/22
Accepted on 27/10/22
Submitted on 21/09/22

Volume 38, Issue 4, 2022
DOI: 10.23967/j.rimni.2022.11.001
Licence: CC BY-NC-SA license

Document Score

0

Views 23
Recommendations 0

Share this document

claim authorship

Are you one of the authors of this document?