Next Article in Journal
Inverse Kinematics of Robotic Manipulators Based on Hybrid Differential Evolution and Jacobian Pseudoinverse Approach
Previous Article in Journal
Optimization of Offshore Saline Aquifer CO2 Storage in Smeaheia Using Surrogate Reservoir Models
Previous Article in Special Issue
Analytical Solution for the Problem of Point Location in Arbitrary Planar Domains
 
 
Font Type:
Arial Georgia Verdana
Font Size:
Aa Aa Aa
Line Spacing:
Column Width:
Background:
Article

Performance Analysis and Parallel Scalability of Numerical Methods for Fractional-in-Space Diffusion Problems with Adaptive Time Stepping

by
Svetozar Margenov
* and
Dimitar Slavchev
Institute of Information and Communication Technologies, Bulgarian Academy of Sciences, 1113 Sofia, Bulgaria
*
Author to whom correspondence should be addressed.
Algorithms 2024, 17(10), 453; https://doi.org/10.3390/a17100453
Submission received: 5 September 2024 / Revised: 8 October 2024 / Accepted: 10 October 2024 / Published: 12 October 2024
(This article belongs to the Special Issue Numerical Optimization and Algorithms: 2nd Edition)

Abstract

:
We study numerical methods and algorithms for time-dependent fractional-in-space diffusion problems. The considered anomalous diffusion is modelled by the fractional Laplacian ( Δ ) α , 0 < α < 1 , following the integral definition. Fractional diffusion is non-local, and the finite element method (FEM) discretization in space leads to a dense stiffness matrix. It is well known that numerically solving such non-local boundary value problems is expensive. Difficulties increase significantly when the problem is time-dependent. The aim of the article is to develop computationally efficient methods and algorithms. There are two main features of our approach. Hierarchical semi-separable (HSS) compression is applied for an approximate solution of the arising linear systems. For time discretization, we use an adaptive forward–backward Euler scheme. The properties of the composite algorithm thus obtained are investigated. In particular, the block representation of HSS compression allowed us to upgrade the HSS solver to efficiently handle varying diagonally perturbed transition matrices corresponding to changing time steps. The contribution of the paper is threefold. The methods are completely constructive, which allows for a clearly structured description of the algorithms. A theoretical estimate of the computational complexity is presented. It shows the advantages of the adaptive time stepping in combination with the HSS solver. Theoretical results are supported by representative numerical experiments. Both sequential and parallel scalability and efficiency are analyzed. The presented results provide convincing proof of the concept of the proposed methods and algorithms.

1. Introduction

Anomalous diffusion has many applications in science and engineering. It is observed in flows in strongly heterogeneous porous media, superconductivity, diffusion of polymers in supercold media [1]; the electrodiffusion of ions into nerve cells [2] and photon diffusion diagnostics [3]; image processing and machine learning [4]; and the spread of viral diseases, computer viruses, and crime [5], to name a few. A more exhaustive review of its applications can be found in [6]. Anomalous diffusion is mathematically modelled with the fractional Laplace operator ( Δ ) α , where α is the fractional power. There are different approaches regarding the definition of fractional Laplacian. For example, the Balakrishnan formula, a formula involving semi-group, and the Dynkins definition based on probabilistic considerations are discussed in [7,8]. It is shown that they are all equivalent in the whole space R d but differ significantly when homogeneous Dirichlet boundary conditions in a bounded domain are enforced. The work of comparing the properties of relevant models is an ongoing process in which various aspects of nonlocal phenomena are analyzed as well as how they describe the available experimental data. In recent years, mathematicians have been particularly active in developing numerical methods for multidimensional boundary value problems in computational domains of general geometry, applying and comparing results for different definitions of fractional Laplacian. In [9], a comparison between the spectral and integral definitions can be found. In this work, we will concentrate on the following integral definition of ( Δ ) α :
Δ α u x = C d , α P . V . R d u x u y | x y | d + 2 α d y , α ( 0 , 1 ) .
Here P.V. stands for principal value, d is the number of spatial dimensions, α is the fractional power, and C ( d , α ) is the following constant
C ( d , α ) = 2 2 α α Γ α + d 2 π d / 2 Γ ( 1 α ) ,
where Γ is the gamma function. The fractional Laplacian is a non-local operator, and after applying a suitable discretization in space, the associated boundary value problems are reduced to solving systems of linear algebraic equations with dense matrices. For real-life problems, solving such systems can be computationally very expensive. If a standard LU or Cholesky decomposition is applied, the computational complexity to solve such a system is O ( N 3 ) , where N is the number of degrees of freedom in space. For the considered parabolic problem, we need to solve a series of such linear systems, and the complexity becomes O ( m N 3 ) , where m is the number of time steps. The aim of this research is to develop a more efficient numerical method with significantly less computational complexity.
In this work, we do not impose any special constraints on the geometry of the space computational domain Ω . Also, in the finite element method (FEM) discretization, the mesh is unstructured by default. This formulation of the problem excludes the possibility of using more specialized linear algebra methods, which are based on a special structure of the stiffness matrix.
In computational mathematics, numerical methods for evolution problems are naturally based on the best available solvers for the corresponding elliptic boundary value problems. In the case of standard (local) diffusion, the stiffness matrix is sparse, and the developed near-optimal implicit methods for parabolic problems use fast preconditioned iterative solution methods (such as algebraic multigrid) for the emergent linear systems. The situation changes substantially when fractional diffusion is involved. The matrices are dense, and the concept of iterative solvers is not applicable in the general case. Furthermore, it turns out that there are specific difficulties depending on the definition of the fractional Laplacian used.
The history of the development of efficient (near-optimal) numerical methods for space-fractional diffusion problems in multidimensional domains of general geometry is less than ten years. And despite the considerable number of publications in this field, there are few results of this type for parabolic problems. Without pretending to be exhaustive, we will briefly touch on some of them. The case of spectral fractional diffusion is considered in [10,11,12,13,14]. The common feature of these results is that they can all be interpreted in terms of certain rational approximations. A further step in the development of this approach, significantly expanding the scope of the investigated problems, can be found in [15,16,17,18]. These works mainly focus on convergence analysis, with less discussion of algorithmic implementation and computational complexity. The same applies to [19], where finite element approximations for integral-fractional evolution problems are analysed. This paper is thematically closest to the parabolic equation we are considering.
Here, we use a rather different pure algebraic approach. Hierarchical semi-separable (HSS) compression is applied to approximately solve the arising linear systems. Earlier results based on HHS compression have been published in [20], where the case of a uniform time step is experimentally analysed.
In this paper, we implement an adaptive forward–backward Euler scheme for discretization in time. The aim is to automatically adapt the method to the evolution of the regularity of the solution. The obtained composite algorithm is analysed. The block representation of HSS compression is used to upgrade the HSS solver. This allows us to efficiently handle different diagonally perturbed transition matrices corresponding to changing time steps. The main contributions of the paper are as follows. The method is fully constructive, leading to a well-structured algorithmic implementation. The theoretical estimate of the computational complexity clearly shows the efficiency of the adaptive time stepping in combination with the HSS solver. The presented numerical experiments support the theoretical results. Both sequential and parallel scalability and efficiency are analyzed. The conclusion is that a convincing proof of concept of the proposed method and algorithm is presented.
In short, the fundamental novelties of the results that will be presented are the complex solutions obtained as a result of the developed composite algorithm. The time discretization is optimized, where the variable time step size adapts to the dynamics in the behavior of the solution. The hidden structure of the dense fractional diffusion stiffness matrix is shown to fit well with the stochastic HSS compression approach, thereby allowing attractive parallel scalability to be reached.
The rest of the paper is organized as follows. The fractional-in-space parabolic problem is presented in the next section, which concludes with the adaptive forward–backward Euler scheme for time discretization. Section 3 is devoted to hierarchical semi-separable compression. A key aspect here is the construction of a modified algorithm for diagonally perturbed matrices. The most important from a theoretical point of view is Section 4, where the computational complexity of the composite algorithm is analysed. The test problem for numerical experiments is then discussed in the next section. An analysis of the results of the conducted sequential and parallel numerical tests is presented in Section 6 and Section 7, respectively. In the next section, the relative error behaviour of the HSS solver is analyzed. The paper ends with a brief discussion of the results obtained.

2. Fractional-in-Space Parabolic Equation

2.1. Continuous Problem

The following parabolic problem with unknown function u ( x , t ) , ( x , t ) Ω × [ 0 , T ] is considered
u ( x , t ) t + ( Δ ) α u ( x , t ) = f ( x , t ) , x Ω , t ( 0 , T ) u ( x , t ) = 0 , x Ω , t ( 0 , T ) u ( x , 0 ) = u 0 ( x ) , x Ω .
Here, Ω is the open space domain, Ω = R d Ω is the complement of Ω , and the open time domain is denoted with t ( 0 , T ) .

2.2. Finite Element Approximation in Space

For the discretization in space of the ( Δ ) α operator, we use a finite element scheme as outlined by Acosta in [21]. Let us consider an admissible triangulation on Ω with N T as number of linear conforming elements. We will denote with { φ 1 , , φ N } V h the nodal basis corresponding to the internal nodes { x 1 , , x N } . The basis functions have the form φ i ( h j ) = δ i j , i , j [ 1 , N ] , where δ is the Kronecker delta. Thus, the ( Δ ) α operator (1) is approximated by the fractional stiffness matrix K = ( K i j ) R N × N such that
K i j = C ( d , α ) 2 φ i , φ j H α ( Ω ) .
where H α ( Ω ) is the following Sobolev space
H α ( Ω ) = { v L 2 ( Ω ) : | v | H α ( Ω ) < } .
It is defined with the Aronszajn–Slobodeckij seminorm
| v | H α ( Ω ) = Ω × Ω ( v ( x ) v ( y ) ) 2 | x y | d + 2 α d x d y 1 2 .
The integrals that must be calculated in order to compute K i j are carried out over the unbounded domain R d . A ball-shaped domain B is introduced around Ω to facilitate their calculations. The distance between the boundary Ω and the compliment B is discussed in [21]. An auxiliary admissible triangulation T A is introduced on B Ω with n A elements. We will denote with n T ˜ = n + n A the number of elements on the combined triangulation T ˜ = T T A . Thus, the coefficients of K can be written as
K i j = C d , α 2 l = 1 n T ˜ k = 1 n T ˜ I l , k i , j + 2 J l i , j , l , k [ 1 , n T ˜ ] .
The integrals I and J are
I l , k i , j = T l T m φ i ( x ) φ i ( y ) φ j ( x ) φ j ( y ) x y d + 2 α d x d y J l i , j = T l B φ i ( x ) φ j ( x ) x y d + 2 α d y d x .
Computing I l , k i , j and J k i , j is a numerically complex task. For this purpose, specialized methods and algorithms are utilized. Specifically, singular integrands are involved in the computation of I, while J is calculated over an unbounded domain. The derivation of the I and J integrals as well as the theoretical analysis of the described finite element scheme is given in [21].

2.3. Backward Euler Discretization in Time

The unconditionally stable backward Euler scheme is implemented, in which the lumped mass matrix M L is used. M L is obtained by summing all off-diagonal elements of the mass matrix M into the diagonal. In this way,
M i i L = j = 0 N M i j , i = 1 , N ,
and thus, the time-stepping method is written in the form
M L u j + 1 u j τ j + K u j + 1 = M L f j + 1 + f j 2 , j = 0 , , m 1 .
Here, ω = { t 0 = 0 , t 1 , , t m = T } is the finite difference mesh in the interval [ 0 , T ] , m is the number of time steps and τ j the size of the jth step. The superscript j means that the value of the mesh function is taken at the node t j . The implementation of the scheme (3) reduces to solving m systems of linear algebraic equations
K ˜ u j + 1 = b ˜ j + 1 , j = 0 , m 1 ,
where
K ˜ j = K + M L τ j , b ˜ j = M L f j + 1 + f j 2 + u j τ j .
Let us assume that the mesh of the time stepping scheme is uniform; that is, τ j = τ . Then, the matrix K ˜ j = K ˜ does not depend on j, and if, for example, LU factorization is applied to solve the linear systems in (4), only one factorization of K ˜ will be needed. The computational complexity of the factorization is O ( N 3 ) and the complexity of solving the system with the factorized matrix is O ( N 2 ) . Thus, the computational complexity of the backward Euler scheme under consideration will be O ( N 3 + m N 2 ) . The parallel performance of LU- and HSS-based solvers for the case of a uniform time stepping is studied in [20].
The parameters τ j control the time discretization error. When the regularity of the problem varies significantly with time, it may be advantageous to apply variable time steps, thus balancing the error. From a computational point of view, the motivation for using variable time steps is to significantly reduce their number compared to the uniform time step case while maintaining the required accuracy of the numerical solution. Such are, for example, the cases of an initial condition with jumps or jumps in time of the right-hand side. Let us assume that in a (by default) small number of subintervals of the time domain, we uniformly refine the step size. Then, the computational complexity of the LU-based solver method becomes O ( q N 3 + m N 2 ) , where q denotes the number of times to perform the LU factorization, which corresponds to the number of times, when τ j τ j + 1 , including the first step τ 1 . The performance of this method for LU- and HSS-based solvers is examined in [22].

2.4. Adaptive Forward–Backward Euler Discretization in Time

The local refinement discussed above implies a more specific regularity of the solution in time that is a priori known. We do not need any such assumptions in this paper. The developed adaptive time stepping algorithm estimates the current error and automatically adjusts the next step size based on it. The procedure is as follows. The approximate solution is calculated using the stable backward Euler scheme (3), while a forward Euler scheme is used to estimate the size of the next time step. This type of methods are widely used in standard (local) diffusion problems. For example, adaptive time stepping for coupled multiscale problems is studied in [23,24], where the solution dynamics arise from nonlinear transitions of material properties. A parabolic equation with a jumping right-hand side is considered in [25], which is closest to the test problem we used in our numerical experiments. The time step adaptation algorithm explored in this paper is largely in the spirit of [25]. The great challenge and novelty of the results presented here are due to the non-locality of fractional diffusion.
Let us consider the semi-discrete Cauchy problem
U t + K U = F
corresponding to the FEM discretization in space of (1), where the vectors U and F represent the nodal functions of the unknown solution u ( x , t ) and the right-hand side f ( x , t ) on T . The error z i + 1 of the backward Euler scheme for (5) can be estimated by
| | z i + 1 | | i = 0 j τ i + 1 | | Ψ i + 1 | | ,
where the truncation error Ψ i + 1 has the form
Ψ i + 1 = F i + 1 U i + 1 U i τ i + 1 K U i + 1 .
Following the notations introduced in the fully discrete case, the superscript j means that the values are taken in the node t j ω . Now, let δ > 0 be the parameter defining the desired accuracy. We are looking for such a time step τ i + 1 that the inequality
Ψ i + 1 τ i + 1 δ
holds. If (7) is satisfied, from (6), we conclude that the error accumulates linearly and is majorized by
| | z i + 1 | | δ t i + 1 .
Unfortunately, it is not possible to apply (6) and (7) directly. This is because, to calculate the truncation error, we need the exact solution U = U ( t ) , which is of course unknown. In the algorithm for the time step selection presented below, we use an approximate truncation error. For this purpose, an auxiliary forward Euler step is performed.
Thus, the numerical solution of the parabolic problem is calculated by applying as the main discretization tool the unconditionally stable forward Euler scheme. Importantly, the additionally included inverse-free forward scheme is significantly cheaper from a computational point of view. It should be noted that this scheme is unstable, which is not a problem, however, because we only apply it locally to estimate τ i + 1 .

Algorithm for Time Step Selection

The adaptive size of τ i + 1 is computed in the following three steps:
  • Prognostic solution. Calculation of u ˜ i + 1 in t ˜ i + 1 = t i + τ ˜ i + 1 using the forward Euler scheme (8).
  • Prognostic error. The prognostic solution u ˜ i + 1 is used to compute the prognostic truncation error Ψ ˜ i + 1 given by (9).
  • Step size selection. The time step τ i + 1 is selected based on the prognostic error and the parameter δ that defines the desired accuracy.
When choosing a predictive time step, we always aim to increase the previous one by multiplying it by a predetermined factor γ > 1 as follows:
τ ˜ i + 1 = γ τ i .
The prognostic solution u ˜ i + 1 is then calculated by the forward Euler scheme
M L u ˜ i + 1 u i τ ˜ i + 1 + K u i = f i .
Here, the approximate truncation error at the prognostic time step is computed in the form
Ψ ˜ i + 1 = f ˜ i + 1 M L u ˜ i + 1 u i τ ˜ i + 1 K u i
where f ˜ i + 1 is the right-hand side at the prognostic time t ˜ i + 1 = t i + γ τ i . That is how we obtain
τ ¯ i + 1 = δ | | Ψ ˜ i + 1 | | γ τ i .
Finally, we apply the constraints that the time step τ i + 1 cannot be less than τ 0 and cannot exceed the estimated time step, and so we obtain
τ i + 1 = τ 0 , if τ ¯ i + 1 < τ 0 , τ ˜ i + 1 , if τ ¯ i + 1 > τ ˜ i + 1 , τ ¯ i + 1 , otherwise .
We also introduce the threshold parameter θ and impose the following step change constraint:
if min τ i + 1 τ i τ i , τ i τ i + 1 τ i + 1 < θ then τ i + 1 : = τ i .
This rule allows us to avoid too small relative changes in the time steps.
One time step of the forward Euler scheme involves matrix-vector multiplication with computational complexity of O ( N 2 ) , while the backward Euler scheme requires additionally solving a dense system of linear algebraic equations that has computational complexity of O ( N 3 ) in the general case when using LU factorization (or any other Gaussian elimination-type method). Thus, the total computational complexity of the discussed adaptive time-stepping method, if a LU factorization solver is used in the implementation, is O ( m N 3 ) . The rest of the paper is aimed at improving the performance of the method by using HSS compression instead of LU factorization.
In conclusion, we note that, in general, the number of time steps m will be much smaller with the adaptive stepping scheme than if we use a uniform scheme with τ = τ 0 .

3. Hierarchical Semi-Separable Compression

Hierarchical compression methods were introduced by Hackbusch in [26] with the H -matrix (see also [27]). The main hypothesis here is that a data-sparse matrix A can be approximated by a matrix in compressed form H. Here, by data-sparse, we mean a matrix where the off-diagonal blocks can be expressed as a product of smaller vectors and matrices. In this work, we use the hierarchically semi-separable compression (HSS) method introduced by Martinsson in [28] and for the numerical experiments, we use the implementation within the STRUctured Matrices PACKage (STRUMPACK) [29,30].
Hierarchical compression was first introduced to solve systems of linear algebraic equations arising from the application of the boundary element method. It is noted by Acosta in [21] that the integrals (2) involved in the computation K are similar to those produced by discretization with the boundary element method. This makes K likely to be a a suitable candidate for hierarchical compression. In [31], we have experimentally verified the suitability of HSS compression for elliptic fractional diffusion problems.

3.1. Basic Relations and Algorithmic Steps

A system of linear algebraic equations in the form A x = b is solved with HSS in three steps.
  • Hierarchical semi-separable compression. The matrix A is divided in four blocks, and the off-diagonal blocks are approximated by a product of three matrices (also called generators) as follows:
    A D 1 U 1 B 1 , 2 V 2 U 2 B 2 , 1 V 1 D 2
    For a suitable matrix A (with low off-diagonal blocks), U generators have few columns, B are small and square or rectangular, and V have few rows. The diagonal blocks D can also be compressed in a similar way and so on recursively until a threshold for the smallest block to be compressed is reached. The maximum rank r of the off-diagonal blocks occurring in the HSS compression of A is calculated. The computational efficiency of the compression can be roughly measured by comparing r to the size of the matrix N. For suitable problems r N . In general, HSS compression is approximate, where random sampling is applied to calculate the generators. The user must supply a relative threshold ε rel and an absolute one ε abs . The computational complexity of the HSS compression is O ( r N 2 ) .
  • ULV-like factorization. A special form of LU factorization called ULV-like factorization can be applied to the thus compressed matrix H. The compression implemented within STRUMPACK uses the structure of the generators, unlike the original ULV factorization, which uses orthogonal transformations [30]. The computational complexity of ULV-like factorization is O ( r 2 N ) .
  • Solving a factorized matrix system. A system of linear algebraic equations with matrix H can be solved by ULV-like factorization with computational complexity O ( r N ) .
The compressed form of the matrix allows faster performance of linear algebraic operations. Thus, multiplying a vector by H has a computational complexity of O ( r N ) . It should also be noted that HSS compression is sensitive to the order of the unknowns. In this work, we use the recursive bisection algorithm to obtain a more suitable off-diagonal structure. This choice is based on results from [31,32].

3.2. Modified Algorithm for Diagonally Perturbed Matrices

We will recall that for the backward Euler scheme, we solve a series of systems of linear algebraic Equation (3). The matrix of each system has the form
K ˜ i = M L τ i + K , i = 1 , , m .
It should be noted that the lumped mass matrix is diagonal and the only part of K ˜ i that would differ between time steps is the main diagonal, and only when the time step changes τ i τ i 1 . On the other hand, we can notice that HSS compression does not change the diagonal values. Thus, we can compress the stiffness matrix K once. Then, only the diagonal is updated when needed. The developed modified Algorithm 1 is implemented using STRUMPACK functionalities.
Algorithm 1 Algorithm for diagonally perturbed matrices with HSS compression
Input: K, M L , t = [ 0 , T ] , f i = f ( t ) , θ , u 0 = u ( 0 ) , γ , δ
Output: u i , τ i , m
i = 0 , t = 0
H = compress(K)▹ Apply HSS compression on the stiffness matrix
while  t T  do
   τ ˜ i + 1 = τ i γ ▹ Increase prognostic step
   u ˜ i + 1 : M L u ˜ i + 1 u i τ ˜ i + 1 + K u i = f i ▹ Compute prognostic solution
   Ψ ˜ i + 1 = f ˜ i + 1 M L u ˜ i + 1 u i τ ˜ i + 1 K u i ▹ Compute truncation error
   τ ¯ i + 1 = δ | | Ψ ˜ i + 1 | | γ τ i ▹ Calculate time step
  if  τ ¯ i + 1 < τ 0  then▹ Apply size limitations to new time step
     τ i + 1 = τ 0
  else if  τ ¯ i + 1 > τ ˜ i + 1  then
     τ i + 1 = τ ˜ i + 1
  else if  | τ ¯ i + 1 τ i τ i |   < θ  or  | τ ¯ i + 1 τ i τ i + 1 |   < θ  then
     τ i + 1 = τ i
  end if
  if  t + τ i + 1 > T  then
     τ i + 1 = T t
  end if
  if  τ i + 1 τ i  then
     H = M L τ i + 1 + H ▹ Perturb the diagonal of H with M L and τ i + 1
    ULV = factor(H)▹ Calculate the ULV factorization of H
  end if
   b ˜ i = M L f i + 1 + f i 2 + u i τ i ▹ Compute right hand side
   u i + 1 = solve(ULV, b ˜ i + 1 )▹ Compute the solution at time t + τ i + 1
   i = i + 1 , t = t + τ i + 1 ▹ Prepare parameters for next time step
  if  τ i + 1 τ i  then
     H = H M L τ i + 1 ▹ Restore original compressed matrix
  end if
end while
m = i

4. Computational Complexity of the Time Stepping Algorithms

Here, we briefly compare the computational complexity of the considered time-stepping algorithms.
LU factorization (or any direct Gaussian elimination method) for solving dense linear systems requires O ( N 3 ) arithmetic operations. More precisely, the computational complexity of the factorization (forward elimination step) is O ( N 3 ) while solving the system with the factorized matrix (backward substitution step) costs O ( N 2 ) operations.
Alternatively, as discussed in Section 3, the solver based on HSS compression requires O ( r N 2 ) arithmetic operations, where r is the maximum rank of the off-diagonal blocks generated in the compression process. The costs of the three consequential steps here are as follows: HSS compression— O ( r N 2 ) ; ULV-like factorization— O ( r 2 N ) ; solving system with a factorized matrix— O ( r N ) .
Let us first consider the case of the backward Euler scheme with a uniform time step τ . Then, the matrix K ˜ = K + M L / τ does not change during the time-stepping procedure, that is, the factorization is performed only once. Thus, the following estimates of the computational complexity of the time-stepping algorithm hold:
N uniform   LU = O ( N 3 ) + O ( m N 2 ) ,
N uniform   HSS = O ( r N 2 ) + O ( m r N ) .
A numerical comparison between these two methods can be found in [22]. Then, in [20], a special case of different time steps is considered, where the time domain is divided into (by default) a small number of subdomains with piecewise constant time steps.
The performance analysis that will be presented in the rest of the paper only applies to the case of adaptive time stepping. In the forward–backward Euler adaptive scheme, the matrix K ˜ i can generally change at each time step. In practice, this does not allow us to reuse the factorization computed at the previous time step.
Let us write the number of time steps m in the form
m = m 1 + m 2 ,
where m 1 denotes the number of times the adaptive forward–backward Euler scheme has changed the step size. Then,
N adaptive   LU = O ( m 1 N 3 + m N 2 ) .
As shown in Section 3.2, the HSS compression is performed only once for the adaptive scheme, while the ULV-like factorization must be performed m 1 times. Therefore, the computational complexity N adaptive   HSS can be estimated by
N adaptive   HSS = O ( r N 2 + m 1 r 2 N + m r N ) .
We should note that the number of steps of the adaptive method m as well as the part m 1 will depend on the parameters set by the user and the behaviour of the right-hand side f ( x , t ) .
In conclusion, the computational complexity analysis shows that we can expect the adaptive scheme to outperform the uniform one if the number of adaptive time steps m is significantly smaller than the number of uniform steps required to cover the same time domain m uniform = T / τ 0 and also when m < N .

5. Test Problem for Numerical Experiments

The test problem is defined in terms of the parabolic Equation (1), such that Ω = ( 1 , 1 ) × ( 1 , 1 ) , T = 0.1 , and an initial condition u 0 ( x ) = 0 . In all numerical experiments, α = 0.5 , which is considered as a representative case to prove the concept of the analysed methods and algorithms.
We denote by f ¯ ( x ) the checker-board function on Ω Ω = ( 1 , 1 ) × ( 1 , 1 )
f ¯ ( x ) = 1 i f x 1 x 2 > 0 1 o t h e r w i s e .
Then the right-hand side of f ( x , t ) L 2 ( Ω × ( 0 , T ) ) has the form
f ( x , t ) = 100 f ¯ ( x ) if t ( 0 , t ˜ 1 ] 200 f ¯ ( x ) if t ( t ˜ 2 , t ˜ 3 ] 0 otherwise ,
where t ˜ 1 = 0.01 , t ˜ 2 = 0.05 and t ˜ 3 = 0.06 . For the adaptive time stepping scheme, we set the parameters γ = 1.5 , δ = 0.01 , and θ = 0.1 . We also apply successive refinement of FEM meshes, resulting in an increase in degrees of freedom in space with N = 2131, 4167, 8030, 12,805, 16,184, 24,892, 32,302.
In the case of adaptive time stepping, the accuracy in time is controlled by the initial time-step τ 0 , which must be aligned with the FEM accuracy in space. Furthermore, in the context of our test problem, τ j must agree on jump points of f ( t ) .
In the performance analysis, we use also results for the backward Euler algorithm with uniform step τ . For this purpose, the relative error in the norm l 2 is used
R j = u j u j + 1 l 2 u j l 2 = i = 1 N ( u i j + 1 u i j ) 2 i = 1 N ( u i j ) 2 ,
where the solution u j is obtained with m = 200 × 2 j , j = 0 , 1 , 2 , . In the considered example, there are several points where f has jumps. To fit them, we add additional checks that will not allow the time step to go beyond these two points. If t i < 0.01 and t ˜ i + 1 > 0.05 , we lower τ ˜ i such that t ˜ i + τ ˜ i = 0.05 . In a similar way, we treat the interval [ 0.05 , 0.06 ] .
In Figure 1, we present the relative errors for N = 2131 with decreasing constant time step τ (the behaviour is quite similar for all seven variants of N). The results shown are for t = 0.025 , 0.05 , 0.075 , 0.1 . The relative error between two consecutive values of the time steps becomes smaller than 10 3 at m = 6400 and smaller than 10 4 at m = 204,800. Based on this simple observation, in the numerical experiments for the adaptive scheme, we will consider the cases m max = 6400 and m max = 204,800, which correspond to τ 0 = 1.5625 × 10 5 and τ 0 = 4.8828125 × 10 7 . As you will see in the next section, the two chosen options for τ 0 turn out to be very representative for the purposes of the presented performance analysis.
Finally, for the absolute and relative threshold used in the HSS compression implemented in STRUMPACK, we will use a fixed ε abs = 10 8 and vary ε rel = 10 2 , 10 4 , 10 6 and 10 8 .

6. Comparative Analysis of Sequential Performance

Here, we analyse the performance of the adaptive scheme compared to the backward Euler algorithm with uniform time step τ = τ 0 . Figure 2 shows the computation times of the sequential algorithms with the LU factorization solver. We see that the adaptive time stepping scheme has a clear advantage in the case of a smaller time step τ 0 = 4.8828125 × 10 7 . This experimental result is fully consistent with the theoretical conclusion in Section 4 that the adaptive method has better computational complexity when m < N . The number of steps generated by the adaptive algorithm is presented in Figure 3. We observe that although the minimum step size is reduced by two orders of magnitude, the amount of adaptive time steps is increased by only a factor of approximately two. In other words, the discussed adaptive strategy leads to a logarithmic increase in the total number of time steps with respect to τ 0 , that is, m = O ( | log τ 0 | ) . This explains the much better computational times of the adaptive method when τ 0 is small enough.
Let us recall that the adaptive forward–backward Euler method developed is explicit. We do not need inner iterations to fit the error estimator. Avoiding inner iterations is an important sought-after property of the algorithm, taking into account the non-locality of the fractional diffusion and the fact that the stiffness matrix is dense.
The following Figure 4 plays a key role in the experimental proof-of-concept of the approach proposed in this paper. Here, we present a comparison of the computational times of the adaptive algorithm with LU-based and HSS-based solvers. For both variants of the minimum time step τ 0 , hierarchical compression performs much better. It should be noted that there is little difference between the results with τ 0 = 1.5625 × 10 5 and τ 0 = 4.8828125 × 10 7 . The reason for this is that most of the steps are relatively larger, except for the locally refined ones around the jump points of f ( x , t ) . Figure 5 illustrates this behaviour of the adaptive step sizes over the entire time interval. We also see the monotonically increasing time steps in the subintervals where the right-hand side does not change. This is consistent with the evolving smoothness of the solution.

7. Parallel Scalability

For large-scale problems, the efficient implementation of computing systems with parallel architecture becomes an increasingly important issue. Solving dense linear systems with block LU-based solvers is a commonly accepted standard for measuring the performance of supercomputers. This approach is used in the well-known LINPACK TOP 500 ranking [33]. And although numerical linear algebra is the backbone of computing in general, evaluating the overall performance of a real-life problem is always a more complex task than benchmarking a single routine. Ensuring a transparent comparison, we follow the steps from Section 6 here, now analyzing the parallel performance. Let us also recall that MKL and STRUMPACK were developed as parallel software packages.
In Figure 6, we present the parallel times for the backward Euler method with a uniform time step and the adaptive forward–backward Euler time stepping scheme. The block LU-based solver from MKL is used. The tests were run on a single server with 16 threads. Similar to the sequential tests, the adaptive scheme has better times for all N values at smaller τ 0 ; see the graph on the right-hand side. However, we also observe a relative improvement in parallel times in the case of τ 0 = 1.5625 × 10 5 . This is because the solution with the already factorized system has a lower parallel speed-up, which can be seen in Figure 7. With 16 threads, the adaptive method achieves up to ∼14 times better computation time than the sequential one, while the speed-up for the uniform time step method is only ∼5. Further details on the parallel speed-up of the LU factorization step and then of the solution step with the factorized matrix system can be found in [22].
In Figure 8, we present the parallel times with LU factorization and HSS-compression-based solvers for the adaptive method. For all experiments, HSS compression outperforms LU factorization. This means that the stiffness matrix obtained from the FEM discretization of the fractional Laplacian is suitable for hierarchical semi-separable compression. Overall, the adaptive algorithm with the HSS compression solver has a lower parallel speed-up of ∼6 (see Figure 9) compared to the adaptive method with LU factorization (see Figure 7), but its better performance is due to the substantially lower computational complexity.

8. Analysis of Relative Errors of the HSS Compression Solver

The hierarchical semi-separable compressed representation of matrices is approximate. In the numerical experiments, we presented computational times and speed-up with four values of the relative threshold that is used in the compression algorithm implemented in the STRUMPACK package. In Figure 10, we show the relative errors with respect to the reference solution obtained by the uniform method with LU factorization. For the backward Euler method with a uniform time step, this relative error is of the order ε rel (see [20]). Here, we show the calculated values of R j at the time points T / 4 , T / 2 , 3 T / 4 , and T, recalling that T = 0.1 . What we see is that for the adaptive method, decreasing the relative threshold after 10 4 does not improve the relative error. And this is exactly what we should expect from the numerical tests, where the desired accuracy parameter was set to δ = 0.01 .

9. Discussion

In the case of standard (local) differential equations, there have been many years of successful work on the development of numerical methods for parabolic problems. In particular, the stiffness and mass matrices are sparse and positive definite if the FEM is applied to discretization in space. Thus, explicit methods have an optimal complexity with respect to N, with an analogous result obtained for implicit methods if fast (e.g., multigrid or multilevel) PCG iterative solvers are used. The methods and algorithms discussed here show how the challenges change substantially when moving from local to non-local problems.
Complex solutions are integrated to ensure the computational efficiency of the developed method. A successful combination of the near-optimal unconditionally stable adaptive backward–forward Euler scheme with the upgraded HSS compression-based solver for the diagonally perturbed stiffness matrices that appear in transient systems is achieved. In addition, although recursive by definition, HSS compression and its implementation in the STRUMPACK software package show promising parallel scalability within the discussed composite algorithm.
The numerical experiments show a very good agreement with the theoretical results, thus proving the concept of the applied research methodology. We note the following conclusions: the advantages of the adaptive scheme increase as the minimum time step decreases; the HSS compression-based solver outperforms the LU factorization; the overall accuracy is effectively controlled by the parameters of the adaptive scheme and the HSS compression.

10. Conclusions

In conclusion, the main contribution of the paper is determined by the development, analysis and implementation of a new highly efficient numerical method and algorithms for parabolic diffusion problems with a fractional Laplacian in space. The theoretical results, including, in particular, computational complexity estimates and scalability analyses, are clearly confirmed by the sequential and parallel numerical tests presented. The adaptive backward–forward Euler scheme optimizes computational complexity by avoiding the need for prior assumptions about the regularity of the solution. The algorithm essentially uses the fact that the time derivative is standard (local). For this reason, the concept of an adaptive time stepping will need extensive further development in the case of fractional (nonlocal) diffusion in time.
The progress made in this paper poses new challenges and creates new opportunities for future research in the development of numerical methods for time-dependent fractional diffusion problems in space. In this context, the following topics are on our short-term priority list: adaptive higher-order schemes; adaptive time steps for spectral fractional diffusion; and combining adaptive time stepping with local mesh refinement and hp-FEM in space.
The present investigations can naturally be extended to more general equations that include a fractional power of the diffusion operator (e.g., the Laplacian). This applies, for example, to the case of reaction and/or convection-type terms, where the monotonicity conditions of the schemes may be of particular interest along with stability issues.
The nonlinear case is a separate topic of great scientific value and practical importance. Here, there are very wide possibilities for implementing and upgrading the adaptive time-stepping methods and algorithms. Such an example is the time-dependent fractional in a space diffusion–reaction system of equations coupled by nonlinear reaction operators [34].

Author Contributions

Methodology, S.M.; investigation, S.M. and D.S.; writing—original draft preparation, D.S.; writing—review and editing, S.M.; visualization, D.S. All authors have read and agreed to the published version of the manuscript.

Funding

The work was partially supported by the Bulgarian National Science Fund under grant No. KP-06-N72/2. The second author was also supported by the Bulgarian Ministry of Education and Science under the National Research Programme Young scientists and postdoctoral students.

Data Availability Statement

Dataset available on request from the authors.

Acknowledgments

The access to the infrastructure of the Centre of Excellence in Informatics and ICT, Grant No BG05M2OP001-1.001-0003, financed by the Science and Education for Smart Growth Operational Program and co-financed by the European Union through the European Structural and Investment funds is acknowledged.

Conflicts of Interest

The authors declare no conflicts of interest.

References

  1. Binder, K.; Bennemann, C.; Baschnagel, J.; Paul, W. Anomalous diffusion of polymers in supercooled melts near the glass transition. In Anomalous Diffusion from Basics to Applications; Pękalski, A., Sznajd-Weron, K., Eds.; Springer: Berlin/Heidelberg, Germany, 1999; pp. 124–139. [Google Scholar]
  2. Langlands, T.; Henry, B.; Wearne, S. Fractional Cable Equation Models for Anomalous Electrodiffusion in Nerve Cells: Finite Domain Solutions. SIAM J. Appl. Math. 2011, 71, 1168–1203. [Google Scholar] [CrossRef]
  3. Taitelbaum, H. Diagnosis using photon diffusion: From brain oxygenation to the fat of the atlantic salmon. In Anomalous Diffusion from Basics to Applications; Pękalski, A., Sznajd-Weron, K., Eds.; Springer: Berlin/Heidelberg, Germany, 1999; pp. 160–174. [Google Scholar]
  4. Rosasco, L.; Belkin, M.; Vito, E.D. On Learning with Integral Operators. J. Mach. Learn. Res. 2010, 11, 905–934. [Google Scholar]
  5. Chaturapruek, S.; Breslau, J.; Yazdi, D.; Kolokolnikov, T.; McCalla, S. Crime modeling with Lèvy flights. SIAM J. Appl. Math. 2013, 73, 1703–1720. [Google Scholar] [CrossRef]
  6. Sun, H.; Zhang, Y.; Baleanu, D.; Chen, W.; Chen, Y. A new collection of real world applications of fractional calculus in science and engineering. Commun. Nonlinear Sci. Numer. Simul. 2018, 64, 213–231. [Google Scholar] [CrossRef]
  7. Kwaśnicki, M. Ten equivalent definitions of the fractional laplace operator. Fract. Calc. Appl. Anal. 2017, 20, 7–51. [Google Scholar] [CrossRef]
  8. Lischke, A.; Pang, G.; Gulian, M.; Song, F.; Glusa, C.; Zheng, X.; Mao, Z.; Cai, W.; Meerschaert, M.M.; Ainsworth, M.; et al. What is the fractional Laplacian? A comparative review with new results. J. Comput. Phys. 2020, 404, 109009. [Google Scholar] [CrossRef]
  9. Harizanov, S.; Margenov, S.; Popivanov, N. Spectral Fractional Laplacian with Inhomogeneous Dirichlet Data: Questions, Problems, Solutions. In Advanced Computing in Industrial Mathematics; Georgiev, I., Kostadinov, H., Lilkova, E., Eds.; Springer: Cham, Switzerland, 2021; pp. 123–138. [Google Scholar] [CrossRef]
  10. Bonito, A.; Lei, W.; Pasciak, J.E. The approximation of parabolic equations involving fractional powers of elliptic operators. J. Comput. Appl. Math. 2017, 315, 32–48. [Google Scholar] [CrossRef]
  11. Markus Melenk, J.; Rieder, A. An exponentially convergent discretization for space–time fractional parabolic equations using hp-FEM. IMA J. Numer. Anal. 2022, 43, 2352–2376. [Google Scholar] [CrossRef]
  12. Nochetto, R.H.; Otárola, E.; Salgado, A.J. A PDE Approach to Space-Time Fractional Parabolic Problems. SIAM J. Numer. Anal. 2016, 54, 848–873. [Google Scholar] [CrossRef]
  13. Vabishchevich, P.N. Splitting schemes for non-stationary problems with a rational approximation for fractional powers of the operator. Appl. Numer. Math. 2021, 165, 414–430. [Google Scholar] [CrossRef]
  14. Vabishchevich, P.N. Numerical Solution of Non-stationary Problems for a Space-Fractional Diffusion Equation. Fract. Calc. Appl. Anal. 2016, 19, 116–139. [Google Scholar] [CrossRef]
  15. Čiegis, R.; Starikovičius, V.; Suboč, O.; Čiegis, R. On Construction of Partially Dimension-Reduced Approximations for Nonstationary Nonlocal Problems of a Parabolic Type. Mathematics 2023, 11, 1984. [Google Scholar] [CrossRef]
  16. Danczul, T.; Hofreither, C.; Schöberl, J. A unified rational Krylov method for elliptic and parabolic fractional diffusion problems. Numer. Linear Algebra Appl. 2023, 30, e2488. [Google Scholar] [CrossRef]
  17. Khristenko, U.; Wohlmuth, B. Solving time-fractional differential equations via rational approximation. IMA J. Numer. Anal. 2022, 43, 1263–1290. [Google Scholar] [CrossRef]
  18. Yang, Y.; Huang, J. Double fast algorithm for solving time-space fractional diffusion problems with spectral fractional Laplacian. Appl. Math. Comput. 2024, 475, 128715. [Google Scholar] [CrossRef]
  19. Acosta, G.; Bersetche, F.M.; Borthagaray, J.P. Finite Element Approximations for Fractional Evolution Problems. Fract. Calc. Appl. Anal. 2019, 22, 767–794. [Google Scholar] [CrossRef]
  20. Slavchev, D.; Margenov, S. Performance Study of Hierarchical Semi-separable Compression Solver for Parabolic Problems with Space-Fractional Diffusion. In Large-Scale Scientific Computing; Lirkov, I., Margenov, S., Eds.; Springer: Cham, Switzerland, 2022; pp. 71–80. [Google Scholar]
  21. Acosta, G.; Borthagaray, J. A Fractional Laplace Equation: Regularity of Solutions and Finite Element Approximations. SIAM J. Numer. Anal. 2017, 55, 472–495. [Google Scholar] [CrossRef]
  22. Slavchev, D.; Margenov, S. On the Application of a Hierarchically Semi-separable Compression for Space-Fractional Parabolic Problems with Varying Time Steps. In Numerical Methods and Applications; Georgiev, I., Datcheva, M., Georgiev, K., Nikolov, G., Eds.; Springer: Cham, Switzerland, 2023; pp. 289–301. [Google Scholar]
  23. Blaheta, R.; Byczanski, P.; Kohut, R.; Starỳ, J. Algorithms for Parallel Fem Modelling of Thermo-Mechanical Phenomena Arising from the Disposal of the Spent Nuclear Fuel. In Elsevier Geo-Engineering Book Series; Elsevier: Amsterdam, The Netherlands, 2004; Volume 2, pp. 395–400. [Google Scholar]
  24. Georgiev, K.; Kosturski, N.; Margenov, S.; Starỳ, J. On adaptive time stepping for large-scale parabolic problems: Computer simulation of heat and mass transfer in vacuum freeze-drying. J. Comput. Appl. Math. 2009, 226, 268–274. [Google Scholar] [CrossRef]
  25. Vabishchevich, P.N.; Vasil’ev, A.O. Time step selection for the numerical solution of boundary value problems for parabolic equations. Comput. Math. Math. Phys. 2017, 57, 843–853. [Google Scholar] [CrossRef]
  26. Hackbusch, W. A Sparse Matrix Arithmetic Based on H-Matrices. Part I: Introduction to H-Matrices. Computing 1999, 62, 89–108. [Google Scholar] [CrossRef]
  27. Hackbusch, W.; Grasedyck, L.; Börm, S. An introduction to hierarchical matrices. Math. Bohem. 2002, 127, 229–241. [Google Scholar] [CrossRef]
  28. Martinsson, P.G. A Fast Randomized Algorithm for Computing a Hierarchically Semiseparable Representation of a Matrix. SIAM J. Matrix Anal. Appl. 2011, 32, 1251–1274. [Google Scholar] [CrossRef]
  29. Xia, J.; Chandrasekaran, S.; Gu, M.; Li, X.S. Fast algorithms for hierarchically semiseparable matrices. Numer. Lin. Alg. Appl. 2010, 17, 953–976. [Google Scholar] [CrossRef]
  30. Rouet, F.H.; Li, X.; Ghysels, P.; Napov, A. A Distributed-Memory Package for Dense Hierarchically Semi-Separable Matrix Computations Using Randomization. ACM Trans. Math. Softw. 2016, 42, 1–35. [Google Scholar] [CrossRef]
  31. Slavchev, D.; Margenov, S.; Georgiev, I. On the application of recursive bisection and nested dissection reorderings for solving fractional diffusion problems using HSS compression. AIP Conf. Proc. 2020, 2302, 120008. [Google Scholar] [CrossRef]
  32. Rebrova, E.; Chávez, G.; Liu, Y.; Ghysels, P.; Li, X.S. A Study of Clustering Techniques and Hierarchical Matrix Formats for Kernel Ridge Regression. In Proceedings of the 2018 IEEE International Parallel and Distributed Processing Symposium Workshops (IPDPSW), Vancouver, BC, Canada, 21–25 May 2018; pp. 883–892. [Google Scholar] [CrossRef]
  33. Dongarra, J.J.; Luszczek, P.; Petitet, A. The LINPACK Benchmark: Past, present and future. Concurr. Comput. Pract. Exp. 2003, 15, 803–820. [Google Scholar] [CrossRef]
  34. Georgiev, K.; Margenov, S. Numerical Methods for Fractional Diffusion-Reaction Problems Based on Operator Splitting and BURA. In Advanced Computing in Industrial Mathematics; Georgiev, I., Kostadinov, H., Lilkova, E., Eds.; Springer: Cham, Switzerland, 2023; pp. 73–84. [Google Scholar]
Figure 1. Backward Euler method with uniform time step: reduction in relative error R j versus decrease in τ for N = 2131.
Figure 1. Backward Euler method with uniform time step: reduction in relative error R j versus decrease in τ for N = 2131.
Algorithms 17 00453 g001
Figure 2. Sequential computational times of the uniform and adaptive schemes with LU factorization from the MKL package.
Figure 2. Sequential computational times of the uniform and adaptive schemes with LU factorization from the MKL package.
Algorithms 17 00453 g002
Figure 3. Number of adaptive steps used for both minimum step sizes.
Figure 3. Number of adaptive steps used for both minimum step sizes.
Algorithms 17 00453 g003
Figure 4. Sequential computational times of adaptive scheme with LU factorization and HSS compression.
Figure 4. Sequential computational times of adaptive scheme with LU factorization and HSS compression.
Algorithms 17 00453 g004
Figure 5. Adaptive time step size over the whole time interval for N = 2131 and τ 0 = 1.5625 × 10 5 with LU solver.
Figure 5. Adaptive time step size over the whole time interval for N = 2131 and τ 0 = 1.5625 × 10 5 with LU solver.
Algorithms 17 00453 g005
Figure 6. Parallel computational times of the uniform and adaptive LU solvers from MKL.
Figure 6. Parallel computational times of the uniform and adaptive LU solvers from MKL.
Algorithms 17 00453 g006
Figure 7. Parallel speed-up (parallel time divided by sequential time) of the uniform and adaptive methods with an LU factorization-based solver. The speed-up is calculated for τ 0 = 4.8828125 × 10 7 experiments but is similar to the other value of τ 0 .
Figure 7. Parallel speed-up (parallel time divided by sequential time) of the uniform and adaptive methods with an LU factorization-based solver. The speed-up is calculated for τ 0 = 4.8828125 × 10 7 experiments but is similar to the other value of τ 0 .
Algorithms 17 00453 g007
Figure 8. Parallel times of the uniform and adaptive schemes with HSS compression and ULV-like factorization from the STRUMPACK package.
Figure 8. Parallel times of the uniform and adaptive schemes with HSS compression and ULV-like factorization from the STRUMPACK package.
Algorithms 17 00453 g008
Figure 9. Parallel speed-up of the HSS compression and ULV-like factorization-based solver for the adaptive algorithm.
Figure 9. Parallel speed-up of the HSS compression and ULV-like factorization-based solver for the adaptive algorithm.
Algorithms 17 00453 g009
Figure 10. Relative errors of the solution with τ 0 = 4.8828125 × 10 7 of the adaptive method with HSS compression in relation to the uniform method with LU factorization for ε rel = 10 2 , 10 4 , 10 6 , 10 8 .
Figure 10. Relative errors of the solution with τ 0 = 4.8828125 × 10 7 of the adaptive method with HSS compression in relation to the uniform method with LU factorization for ε rel = 10 2 , 10 4 , 10 6 , 10 8 .
Algorithms 17 00453 g010
Disclaimer/Publisher’s Note: The statements, opinions and data contained in all publications are solely those of the individual author(s) and contributor(s) and not of MDPI and/or the editor(s). MDPI and/or the editor(s) disclaim responsibility for any injury to people or property resulting from any ideas, methods, instructions or products referred to in the content.

Share and Cite

MDPI and ACS Style

Margenov, S.; Slavchev, D. Performance Analysis and Parallel Scalability of Numerical Methods for Fractional-in-Space Diffusion Problems with Adaptive Time Stepping. Algorithms 2024, 17, 453. https://doi.org/10.3390/a17100453

AMA Style

Margenov S, Slavchev D. Performance Analysis and Parallel Scalability of Numerical Methods for Fractional-in-Space Diffusion Problems with Adaptive Time Stepping. Algorithms. 2024; 17(10):453. https://doi.org/10.3390/a17100453

Chicago/Turabian Style

Margenov, Svetozar, and Dimitar Slavchev. 2024. "Performance Analysis and Parallel Scalability of Numerical Methods for Fractional-in-Space Diffusion Problems with Adaptive Time Stepping" Algorithms 17, no. 10: 453. https://doi.org/10.3390/a17100453

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

Article Metrics

Back to TopTop