scispace - formally typeset
Search or ask a question

Showing papers in "arXiv: Numerical Analysis in 2017"


Journal ArticleDOI
TL;DR: A new algorithm for solving parabolic partial differential equation (PDEs) and backward stochastic differential equations (BSDEs) in high dimension is studied, based on an analogy between the BSDE and reinforcement learning with the gradient of the solution playing the role of the policy function, and the loss function given by the error between the prescribed terminal condition and the solution of theBSDE.
Abstract: We propose a new algorithm for solving parabolic partial differential equations (PDEs) and backward stochastic differential equations (BSDEs) in high dimension, by making an analogy between the BSDE and reinforcement learning with the gradient of the solution playing the role of the policy function, and the loss function given by the error between the prescribed terminal condition and the solution of the BSDE. The policy function is then approximated by a neural network, as is done in deep reinforcement learning. Numerical results using TensorFlow illustrate the efficiency and accuracy of the proposed algorithms for several 100-dimensional nonlinear PDEs from physics and finance such as the Allen-Cahn equation, the Hamilton-Jacobi-Bellman equation, and a nonlinear pricing model for financial derivatives.

233 citations


Posted Content
TL;DR: In this paper, a scalar auxiliary variable (SAV) approach is proposed to deal with nonlinear terms in gradient flows, which is not restricted to specific forms of the nonlinear part of the free energy and only requires to solve linear equations with constant coefficients.
Abstract: We propose a new numerical technique to deal with nonlinear terms in gradient flows. By introducing a scalar auxiliary variable (SAV), we construct efficient and robust energy stable schemes for a large class of gradient flows. The SAV approach is not restricted to specific forms of the nonlinear part of the free energy, and only requires to solve {\it decoupled} linear equations with {\it constant coefficients}. We use this technique to deal with several challenging applications which can not be easily handled by existing approaches, and present convincing numerical results to show that our schemes are not only much more efficient and easy to implement, but can also better capture the physical properties in these models. Based on this SAV approach, we can construct unconditionally second-order energy stable schemes; and we can easily construct even third or fourth order BDF schemes, although not unconditionally stable, which are very robust in practice. In particular, when coupled with an adaptive time stepping strategy, the SAV approach can be extremely efficient and accurate.

146 citations


Journal ArticleDOI
TL;DR: In this paper, a neural-network based method is proposed to parameterize the physical quantity of interest as a function of input coefficients, which can be viewed as performing time evolution to find the solutions to the PDE.
Abstract: The curse of dimensionality is commonly encountered in numerical partial differential equations (PDE), especially when uncertainties have to be modeled into the equations as random coefficients. However, very often the variability of physical quantities derived from a PDE can be captured by a few features on the space of the coefficient fields. Based on such an observation, we propose using a neural-network (NN) based method to parameterize the physical quantity of interest as a function of input coefficients. The representability of such quantity using a neural-network can be justified by viewing the neural-network as performing time evolution to find the solutions to the PDE. We further demonstrate the simplicity and accuracy of the approach through notable examples of PDEs in engineering and physics.

132 citations


Posted Content
TL;DR: In this article, a family of virtual element methods for the 2D Navier-Stokes equations is proposed and analyzed, and a rigorous error analysis is developed, showing that the methods are stable and optimally convergent.
Abstract: A family of Virtual Element Methods for the 2D Navier-Stokes equations is proposed and analysed. The schemes provide a discrete velocity field which is point-wise divergence-free. A rigorous error analysis is developed, showing that the methods are stable and optimally convergent. Several numerical tests are presented, confirming the theoretical predictions. A comparison with some mixed finite elements is also performed.

111 citations


Journal ArticleDOI
TL;DR: In this paper, the authors proposed a new method for solving high-dimensional fully nonlinear second-order partial differential equations (PDE), which can be used to sample from highdimensional nonlinear expectations.
Abstract: High-dimensional partial differential equations (PDE) appear in a number of models from the financial industry, such as in derivative pricing models, credit valuation adjustment (CVA) models, or portfolio optimization models. The PDEs in such applications are high-dimensional as the dimension corresponds to the number of financial assets in a portfolio. Moreover, such PDEs are often fully nonlinear due to the need to incorporate certain nonlinear phenomena in the model such as default risks, transaction costs, volatility uncertainty (Knightian uncertainty), or trading constraints in the model. Such high-dimensional fully nonlinear PDEs are exceedingly difficult to solve as the computational effort for standard approximation methods grows exponentially with the dimension. In this work we propose a new method for solving high-dimensional fully nonlinear second-order PDEs. Our method can in particular be used to sample from high-dimensional nonlinear expectations. The method is based on (i) a connection between fully nonlinear second-order PDEs and second-order backward stochastic differential equations (2BSDEs), (ii) a merged formulation of the PDE and the 2BSDE problem, (iii) a temporal forward discretization of the 2BSDE and a spatial approximation via deep neural nets, and (iv) a stochastic gradient descent-type optimization procedure. Numerical results obtained using ${\rm T{\small ENSOR}F{\small LOW}}$ in ${\rm P{\small YTHON}}$ illustrate the efficiency and the accuracy of the method in the cases of a $100$-dimensional Black-Scholes-Barenblatt equation, a $100$-dimensional Hamilton-Jacobi-Bellman equation, and a nonlinear expectation of a $ 100 $-dimensional $ G $-Brownian motion.

110 citations


Journal ArticleDOI
TL;DR: This paper test the applicability of a family of approximation methods based on Picard approximations and multilevel Monte Carlo methods on a variety of 100-dimensional nonlinear PDEs that arise in physics and finance by means of numerical simulations presenting approximation accuracy against runtime.
Abstract: Parabolic partial differential equations (PDEs) and backward stochastic differential equations (BSDEs) are key ingredients in a number of models in physics and financial engineering. In particular, parabolic PDEs and BSDEs are fundamental tools in the state-of-the-art pricing and hedging of financial derivatives. The PDEs and BSDEs appearing in such applications are often high-dimensional and nonlinear. Since explicit solutions of such PDEs and BSDEs are typically not available, it is a very active topic of research to solve such PDEs and BSDEs approximately. In the recent article [E, W., Hutzenthaler, M., Jentzen, A., and Kruse, T. Linear scaling algorithms for solving high-dimensional nonlinear parabolic differential equations. arXiv:1607.03295 (2017)] we proposed a family of approximation methods based on Picard approximations and multilevel Monte Carlo methods and showed under suitable regularity assumptions on the exact solution for semilinear heat equations that the computational complexity is bounded by $O( d \, \epsilon^{-(4+\delta)})$ for any $\delta\in(0,\infty)$, where $d$ is the dimensionality of the problem and $\epsilon\in(0,\infty)$ is the prescribed accuracy. In this paper, we test the applicability of this algorithm on a variety of $100$-dimensional nonlinear PDEs that arise in physics and finance by means of numerical simulations presenting approximation accuracy against runtime. The simulation results for these 100-dimensional example PDEs are very satisfactory in terms of accuracy and speed. In addition, we also provide a review of other approximation methods for nonlinear PDEs and BSDEs from the literature.

90 citations


Posted Content
TL;DR: Numerical experiments show that the PDE-Net has the potential to uncover the hidden PDE of the observed dynamics, and predict the dynamical behavior for a relatively long time, even in a noisy environment.
Abstract: In this paper, we present an initial attempt to learn evolution PDEs from data. Inspired by the latest development of neural network designs in deep learning, we propose a new feed-forward deep network, called PDE-Net, to fulfill two objectives at the same time: to accurately predict dynamics of complex systems and to uncover the underlying hidden PDE models. The basic idea of the proposed PDE-Net is to learn differential operators by learning convolution kernels (filters), and apply neural networks or other machine learning methods to approximate the unknown nonlinear responses. Comparing with existing approaches, which either assume the form of the nonlinear response is known or fix certain finite difference approximations of differential operators, our approach has the most flexibility by learning both differential operators and the nonlinear responses. A special feature of the proposed PDE-Net is that all filters are properly constrained, which enables us to easily identify the governing PDE models while still maintaining the expressive and predictive power of the network. These constrains are carefully designed by fully exploiting the relation between the orders of differential operators and the orders of sum rules of filters (an important concept originated from wavelet theory). We also discuss relations of the PDE-Net with some existing networks in computer vision such as Network-In-Network (NIN) and Residual Neural Network (ResNet). Numerical experiments show that the PDE-Net has the potential to uncover the hidden PDE of the observed dynamics, and predict the dynamical behavior for a relatively long time, even in a noisy environment.

77 citations


Book ChapterDOI
TL;DR: It is shown that smooth, multivariate functions possess expansions in orthogonal polynomial bases that are not only approximately sparse but possess a particular type of structured sparsity defined by so-called lower sets, and the curse of dimensionality – the bane of high-dimensional approximation – is mitigated to a significant extent.
Abstract: In recent years, the use of sparse recovery techniques in the approximation of high-dimensional functions has garnered increasing interest. In this work we present a survey of recent progress in this emerging topic. Our main focus is on the computation of polynomial approximations of high-dimensional functions on d-dimensional hypercubes. We show that smooth, multivariate functions possess expansions in orthogonal polynomial bases that are not only approximately sparse but possess a particular type of structured sparsity defined by so-called lower sets. This structure can be exploited via the use of weighted l1 minimization techniques, and, as we demonstrate, doing so leads to sample complexity estimates that are at most logarithmically dependent on the dimension d. Hence the curse of dimensionality – the bane of high-dimensional approximation – is mitigated to a significant extent. We also discuss several practical issues, including unknown noise (due to truncation or numerical error), and highlight a number of open problems and challenges.

74 citations


Posted Content
TL;DR: In this article, error analysis on virtual element methods including inverse inequalities, norm equivalence, and interpolation error estimates are presented for polygonal meshes which admit a virtual quasi-uniform triangulation.
Abstract: Some error analysis on virtual element methods including inverse inequalities, norm equivalence, and interpolation error estimates are presented for polygonal meshes which admits a virtual quasi-uniform triangulation.

70 citations


Journal ArticleDOI
TL;DR: In this paper, a randomized algorithm for computing the near-optimal low-rank dynamic mode decomposition (DMD) is presented, which is presented in a modular probabilistic framework and the approximation quality can be controlled via oversampling and power iterations.
Abstract: This paper presents a randomized algorithm for computing the near-optimal low-rank dynamic mode decomposition (DMD). Randomized algorithms are emerging techniques to compute low-rank matrix approximations at a fraction of the cost of deterministic algorithms, easing the computational challenges arising in the area of `big data'. The idea is to derive a small matrix from the high-dimensional data, which is then used to efficiently compute the dynamic modes and eigenvalues. The algorithm is presented in a modular probabilistic framework, and the approximation quality can be controlled via oversampling and power iterations. The effectiveness of the resulting randomized DMD algorithm is demonstrated on several benchmark examples of increasing complexity, providing an accurate and efficient approach to extract spatiotemporal coherent structures from big data in a framework that scales with the intrinsic rank of the data, rather than the ambient measurement dimension. For this work we assume that the dynamics of the problem under consideration is evolving on a low-dimensional subspace that is well characterized by a fast decaying singular value spectrum.

70 citations


Posted Content
TL;DR: In this article, a numerical assessment of the Virtual Element Method for discretization of a diffusion-reaction model problem, for higher "polynomial" order k and three space dimensions, is presented.
Abstract: We develop a numerical assessment of the Virtual Element Method for the discretization of a diffusion-reaction model problem, for higher "polynomial" order k and three space dimensions. Although the main focus of the present study is to illustrate some h-convergence tests for different orders k, we also hint on other interesting aspects such as structured polyhedral Voronoi meshing, robustness in the presence of irregular grids, sensibility to the stabilization parameter and convergence with respect to the order k.

Journal ArticleDOI
TL;DR: In this paper, the authors considered the numerical approximations for a phase field model consisting of incompressible Navier-Stokes equations with a generalized Navier boundary condition, and the Cahn-Hilliard equation with a dynamic moving contact line boundary condition.
Abstract: We consider the numerical approximations for a phase field model consisting of incompressible Navier--Stokes equations with a generalized Navier boundary condition, and the Cahn-Hilliard equation with a dynamic moving contact line boundary condition. A crucial and challenging issue for solving this model numerically is the time marching problem, due to the high order, nonlinear, and coupled properties of the system. We solve this issue by developing two linear, second order accurate, and energy stable schemes based on the projection method for the Navier--Stokes equations, the invariant energy quadratization for the nonlinear gradient terms in the bulk and boundary, and a subtle implicit-explicit treatment for the stress and convective terms. The well-posedness of the semidiscretized system and the unconditional energy stabilities are proved. Various numerical results based on a spectral-Galerkin spatial discretization are presented to verify the accuracy and efficiency of the proposed schemes.

Journal ArticleDOI
TL;DR: In this article, the stability analysis of a three-field formulation of Biot's consolidation model is studied, where the unknown variables are the displacements, fluid flux (Darcy velocity), and pore pressure.
Abstract: This paper is devoted to the stability analysis of a classical three-field formulation of Biot's consolidation model where the unknown variables are the displacements, fluid flux (Darcy velocity), and pore pressure Specific parameter-dependent norms provide the key in establishing the full parameter-robust inf-sup stability of the continuous problem Therefore, stability results presented here are uniform not only with respect to the Lame parameter $\lambda$, but also with respect to all the other model parameters This allows for the construction of a uniform block diagonal preconditioner within the framework of operator preconditioning Stable discretizations that meet the required conditions for full robustness and guarantee mass conservation, both locally and globally, are discussed and corresponding optimal error estimates proven

Posted Content
TL;DR: In this paper, the authors introduce a new family of strong linearizations of matrix polynomials called block Kronecker pencils and perform a backward stability analysis of complete polynomial eigenproblems.
Abstract: We introduce a new family of strong linearizations of matrix polynomials---which we call "block Kronecker pencils"---and perform a backward stability analysis of complete polynomial eigenproblems. These problems are solved by applying any backward stable algorithm to a block Kronecker pencil, such as the staircase algorithm for singular pencils or the QZ algorithm for regular pencils. This stability analysis allows us to identify those block Kronecker pencils that yield a computed complete eigenstructure which is exactly that of a slightly perturbed matrix polynomial. The global backward error analysis in this work presents for the first time the following key properties: it is a rigurous analysis valid for finite perturbations (i.e., it is not a first order analysis), it provides precise bounds, it is valid simultaneously for a large class of linearizations, and it establishes a framework that may be generalized to other classes of linearizations. These features are related to the fact that block Kronecker pencils are a particular case of the new family of "strong block minimal bases pencils", which are robust under certain perturbations and, so, include certain perturbations of block Kronecker pencils. We hope that this robustness property will allow us to extend the results in this paper to other contexts.

Posted Content
TL;DR: In this article, the authors show that the original Bassi and Rebay scheme can be provably stable if the metric identities are discretely satisfied, a two-point average for the metric terms is used for the contravariant fluxes in the volume, an entropy conserving split form for the advective volume integrals, the auxiliary gradients for the viscous terms are computed from gradients of entropy variables, and the BR1 scheme was used for interface fluxes.
Abstract: We show how to modify the original Bassi and Rebay scheme (BR1) [F. Bassi and S. Rebay, A High Order Accurate Discontinuous Finite Element Method for the Numerical Solution of the Compressible Navier-Stokes Equations, Journal of Computational Physics, 131:267--279, 1997] to get a provably stable discontinuous Galerkin collocation spectral element method (DGSEM) with Gauss-Lobatto (GL) nodes for the compressible Navier-Stokes equations (NSE) on three dimensional curvilinear meshes. Specifically, we show that the BR1 scheme can be provably stable if the metric identities are discretely satisfied, a two-point average for the metric terms is used for the contravariant fluxes in the volume, an entropy conserving split form is used for the advective volume integrals, the auxiliary gradients for the viscous terms are computed from gradients of entropy variables, and the BR1 scheme is used for the interface fluxes. Our analysis shows that even with three dimensional curvilinear grids, the BR1 fluxes do not add artificial dissipation at the interior element faces. Thus, the BR1 interface fluxes preserve the stability of the discretization of the advection terms and we get either energy stability or entropy-stability for the linear or nonlinear compressible NSE, respectively.

Book ChapterDOI
TL;DR: This work considers a numerical approach for the incompressible surface Navier-Stokes equation based on the covariant form and uses discrete exterior calculus in space and a semi-implicit discretization in time to handle harmonic vector fields.
Abstract: We consider a numerical approach for the incompressible surface Navier-Stokes equation. The approach is based on the covariant form and uses discrete exterior calculus (DEC) in space and a semi-implicit discretization in time. The discretization is described in detail and related to finite difference schemes on staggered grids in flat space for which we demonstrate second order convergence. We compare computational results with a vorticity-stream function approach for surfaces with genus \(g(\mathcal{S}) = 0\) and demonstrate the interplay between topology, geometry and flow properties. Our discretization also allows to handle harmonic vector fields, which we demonstrate on a torus.

Journal ArticleDOI
TL;DR: In this paper, the authors considered the application of the finite difference method for a class of novel multi-term time fractional viscoelastic non-Newtonian fluid models and derived two different finite difference schemes to approximate the model.
Abstract: In recent years, non-Newtonian fluids have received much attention due to their numerous applications, such as plastic manufacture and extrusion of polymer fluids. They are more complex than Newtonian fluids because the relationship between shear stress and shear rate is nonlinear. One particular subclass of non-Newtonian fluids is the generalized Oldroyd-B fluid, which is modelled using terms involving multi-term time fractional diffusion and reaction. In this paper, we consider the application of the finite difference method for this class of novel multi-term time fractional viscoelastic non-Newtonian fluid models. An important contribution of the work is that the new model not only has a multi-term time derivative, of which the fractional order indices range from 0 to 2, but also possesses a special time fractional operator on the spatial derivative that is challenging to approximate. There appears to be no literature reported on the numerical solution of this type of equation. We derive two new different finite difference schemes to approximate the model. Then we establish the stability and convergence analysis of these schemes based on the discrete $H^1$ norm and prove that their accuracy is of $O(\tau+h^2)$ and $O(\tau^{\min\{3-\gamma_s,2-\alpha_q,2-\beta\}}+h^2)$, respectively. Finally, we verify our methods using two numerical examples and apply the schemes to simulate an unsteady magnetohydrodynamic (MHD) Couette flow of a generalized Oldroyd-B fluid model. Our methods are effective and can be extended to solve other non-Newtonian fluid models such as the generalized Maxwell fluid model, the generalized second grade fluid model and the generalized Burgers fluid model.

Posted Content
TL;DR: In this article, the Adams-Bashforth method for fractional differentiation has been improved by taking into account the nonlinearity of the kernels including the power law for Riemann-Liouville type, the exponential decay law for Caputo-Fabrizio case and the Mittag-Leffler law for the Atangana-Baleanu scenario.
Abstract: In the present case, we propose the correct version of the fractional Adams-Bashforth methods which take into account the nonlinearity of the kernels including the power law for the Riemann-Liouville type, the exponential decay law for the Caputo-Fabrizio case and the Mittag-Leffler law for the Atangana-Baleanu scenario. The Adams-Bashforth method for fractional differentiation suggested and are commonly use in the literature nowadays is not mathematically correct and the method was derived without taking into account the nonlinearity of the power law kernel. Unlike the proposed version found in the literature, our approximation, in all the cases, we are able to recover the standard case whenever the fractional power $\alpha=1$.

Posted Content
TL;DR: In this article, the authors explored the features of the Virtual Element Method (VEM) formulation when material nonlinearity is considered, showing that the accuracy and easiness of implementation discovered in the analysis inherent to the first part of the work are still retained.
Abstract: The present paper is the second part of a twofold work, whose first part is reported in [3], concerning a newly developed Virtual Element Method (VEM) for 2D continuum problems. The first part of the work proposed a study for linear elastic problem. The aim of this part is to explore the features of the VEM formulation when material nonlinearity is considered, showing that the accuracy and easiness of implementation discovered in the analysis inherent to the first part of the work are still retained. Three different nonlinear constitutive laws are considered in the VEM formulation. In particular, the generalized viscoplastic model, the classical Mises plasticity with isotropic/kinematic hardening and a shape memory alloy (SMA) constitutive law are implemented. The versatility with respect to all the considered nonlinear material constitutive laws is demonstrated through several numerical examples, also remarking that the proposed 2D VEM formulation can be straightforwardly implemented as in a standard nonlinear structural finite element method (FEM) framework.

Journal ArticleDOI
TL;DR: In this paper, the authors present a mixed-dimensional Darcy problem able to describe pressure and Darcy velocity in all the dimensions, i.e. in the rock matrix, in the fractures, and in their intersections.
Abstract: The accurate description of fluid flow and transport in fractured porous media is of paramount importance to capture the macroscopic behaviour of an oil reservoir, a geothermal system, or a CO2 sequestration site, to name few applications. The construction of accurate simulation model for flow in fractures is challenging due to the high ratios between a fracture's length and width, which makes modeling by lower-dimensional manifolds a natural option. In this paper we present a mixed-dimensional Darcy problem able to describe pressure and Darcy velocity in all the dimensions, i.e. in the rock matrix, in the fractures, and in their intersections. Moreover, we present a mixed-dimensional transport problem which, given the Darcy velocity, describes coupled advection and diffusion of a passive scalar into the fractured porous media. The approach can handle both conducting and blocking fractures. Our computational grids are created by coarsening of simplex tessellations that conform to the fractures surfaces. An accurate choice of the discrete approximation of the previous model, by virtual finite element and finite volume, allows us to simulate complex problem with a good balance in term of accuracy and computational cost. We illustrate the performance of our method by comparing to benchmark studies for two-dimensional fractured porous media, as well as a complex three-dimensional fracture geometry.

Posted Content
TL;DR: In this paper, an energy stable numerical scheme for the Cahn-Hilliard equation, with second order accuracy in time and the fourth order finite difference approximation in space, was proposed and analyzed via the help of discrete Fourier analysis instead of the standard Taylor expansion.
Abstract: In this paper we propose and analyze an energy stable numerical scheme for the Cahn-Hilliard equation, with second order accuracy in time and the fourth order finite difference approximation in space. In particular, the truncation error for the long stencil fourth order finite difference approximation, over a uniform numerical grid with a periodic boundary condition, is analyzed, via the help of discrete Fourier analysis instead of the the standard Taylor expansion. This in turn results in a reduced regularity requirement for the test function. In the temporal approximation, we apply a second order BDF stencil, combined with a second order extrapolation formula applied to the concave diffusion term, as well as a second order artificial Douglas-Dupont regularization term, for the sake of energy stability. As a result, the unique solvability, energy stability are established for the proposed numerical scheme, and an optimal rate convergence analysis is derived in the $\ell^\infty (0,T; \ell^2) \cap \ell^2 (0,T; H_h^2)$ norm. A few numerical experiments are presented, which confirm the robustness and accuracy of the proposed scheme.

Posted Content
TL;DR: A new second-order method for approximating the compressible Euler equations is introduced, which preserves all the known invariant domains of the Euler system: positivity of the density, positive of the internal energy and the local minimum principle on the specific entropy.
Abstract: A new second-order method for approximating the compressible Euler equations is introduced. The method preserves all the known invariant domains of the Euler system: positivity of the density, positivity of the internal energy and the local minimum principle on the specific entropy. The technique combines a first-order, invariant domain preserving, Guaranteed Maximum Speed method using a Graph Viscosity (GMS-GV1) with an invariant domain violating, but entropy consistent, high-order method. Invariant domain preserving auxiliary states, naturally produced by the GMS-GV1 method, are used to define local bounds for the high-order method which is then made invariant domain preserving via a convex limiting process. Numerical tests confirm the second-order accuracy of the new GMS-GV2 method in the maximum norm, where 2 stands for second-order. The proposed convex limiting is generic and can be applied to other approximation techniques and other hyperbolic systems.

Journal ArticleDOI
TL;DR: In this paper, a sampling method by using scattering amplitude is proposed for shape and location reconstruction in inverse acoustic scattering problems, where only matrix multiplication is involved in the computation, thus the novel sampling method is very easy and simple to implement.
Abstract: A sampling method by using scattering amplitude is proposed for shape and location reconstruction in inverse acoustic scattering problems. Only matrix multiplication is involved in the computation, thus the novel sampling method is very easy and simple to implement. With the help of the factorization of the far field operator, we establish an inf-criterion for characterization of underlying scatterers. This result is then used to give a lower bound of the proposed indicator functional for sampling points inside the scatterers. While for the sampling points outside the scatterers, we show that the indicator functional decays like the bessel functions as the sampling point goes away from the boundary of the scatterers. We also show that the proposed indicator functional continuously dependents on the scattering amplitude, this further implies that the novel sampling method is extremely stable with respect to errors in the data. Different to the classical sampling method such as the linear sampling method or the factorization method, from the numerical point of view, the novel indicator takes its maximum near the boundary of the underlying target and decays like the bessel functions as the sampling points go away from the boundary. The numerical simulations also show that the proposed sampling method can deal with multiple multiscale case, even the different components are close to each other.

Journal ArticleDOI
TL;DR: In this article, a semi-discrete dispersion relation of the Parareal parallel-in-time integration method is analyzed for hyperbolic equations and phase errors in the coarse propagator are identified as the main cause of the instability.
Abstract: The paper derives and analyses the (semi-)discrete dispersion relation of the Parareal parallel-in-time integration method. It investigates Parareal's wave propagation characteristics with the aim to better understand what causes the well documented stability problems for hyperbolic equations. The analysis shows that the instability is caused by convergence of the amplification factor to the exact value from above for medium to high wave numbers. Phase errors in the coarse propagator are identified as the culprit, which suggests that specifically tailored coarse level methods could provide a remedy.

Posted Content
TL;DR: In this article, the authors show that for covariance functions that are Green's functions of elliptic boundary value problems and homogeneously-distributed sampling points, an approximate sparse PCA with optimal rate of convergence in the operator norm can be obtained in time complexity O(N \log (N) \log(N)
Abstract: Dense kernel matrices $\Theta \in \mathbb{R}^{N \times N}$ obtained from point evaluations of a covariance function $G$ at locations $\{ x_{i} \}_{1 \leq i \leq N} \subset \mathbb{R}^{d}$ arise in statistics, machine learning, and numerical analysis. For covariance functions that are Green's functions of elliptic boundary value problems and homogeneously-distributed sampling points, we show how to identify a subset $S \subset \{ 1 , \dots , N \}^2$, with $\# S = O ( N \log (N) \log^{d} ( N /\epsilon ) )$, such that the zero fill-in incomplete Cholesky factorisation of the sparse matrix $\Theta_{ij} 1_{( i, j ) \in S}$ is an $\epsilon$-approximation of $\Theta$. This factorisation can provably be obtained in complexity $O ( N \log( N ) \log^{d}( N /\epsilon) )$ in space and $O ( N \log^{2}( N ) \log^{2d}( N /\epsilon) )$ in time, improving upon the state of the art for general elliptic operators; we further present numerical evidence that $d$ can be taken to be the intrinsic dimension of the data set rather than that of the ambient space. The algorithm only needs to know the spatial configuration of the $x_{i}$ and does not require an analytic representation of $G$. Furthermore, this factorization straightforwardly provides an approximate sparse PCA with optimal rate of convergence in the operator norm. Hence, by using only subsampling and the incomplete Cholesky factorization, we obtain, at nearly linear complexity, the compression, inversion and approximate PCA of a large class of covariance matrices. By inverting the order of the Cholesky factorization we also obtain a solver for elliptic PDE with complexity $O ( N \log^{d}( N /\epsilon) )$ in space and $O ( N \log^{2d}( N /\epsilon) )$ in time, improving upon the state of the art for general elliptic operators.

Book ChapterDOI
TL;DR: This survey introduces several examples of kinetic models, that are mathematically described by nonlinear Vlasov and Fokker–Planck equations, and present different numerical approaches for uncertainty quantification which preserve the main features of the kinetic solution.
Abstract: Kinetic equations play a major rule in modeling large systems of interacting particles. Recently the legacy of classical kinetic theory found novel applications in socio-economic and life sciences, where processes characterized by large groups of agents exhibit spontaneous emergence of social structures. Well-known examples are the formation of clusters in opinion dynamics, the appearance of inequalities in wealth distributions, flocking and milling behaviors in swarming models, synchronization phenomena in biological systems and lane formation in pedestrian traffic. The construction of kinetic models describing the above processes, however, has to face the difficulty of the lack of fundamental principles since physical forces are replaced by empirical social forces. These empirical forces are typically constructed with the aim to reproduce qualitatively the observed system behaviors, like the emergence of social structures, and are at best known in terms of statistical information of the modeling parameters. For this reason the presence of random inputs characterizing the parameters uncertainty should be considered as an essential feature in the modeling process. In this survey we introduce several examples of such kinetic models, that are mathematically described by nonlinear Vlasov and Fokker–Planck equations, and present different numerical approaches for uncertainty quantification which preserve the main features of the kinetic solution.

Posted Content
TL;DR: In this article, the authors consider the case of a fixed curved boundary in two dimensions, and show that the proposed curved VEM leads to an optimal rate of convergence, both theoretically and numerically.
Abstract: In this paper we initiate the investigation of Virtual Elements with curved faces. We consider the case of a fixed curved boundary in two dimensions, as it happens in the approximation of problems posed on a curved domain or with a curved interface. While an approximation of the domain with polygons leads, for degree of accuracy $k \geq 2$, to a sub-optimal rate of convergence, we show (both theoretically and numerically) that the proposed curved VEM lead to an optimal rate of convergence.

Posted Content
TL;DR: The analysis of the dynamical behaviour of the ensemble allows us to establish well-posedness and convergence results for a fixed ensemble size and focuses on linear inverse problems where a very complete theoretical analysis is possible.
Abstract: We present an analysis of ensemble Kalman inversion, based on the continuous time limit of the algorithm. The analysis of the dynamical behaviour of the ensemble allows us to establish well-posedness and convergence results for a fixed ensemble size. We will build on the results presented in [26] and generalise them to the case of noisy observational data, in particular the influence of the noise on the convergence will be investigated, both theoretically and numerically. We focus on linear inverse problems where a very complete theoretical analysis is possible.

Journal ArticleDOI
TL;DR: In this article, the restricted Dirichlet-to-Neumann map (DN) is defined and a new numerical concept for CIPs with restricted DN data for a broad class of PDEs of the second order, e.g. elliptic, parabolic and hyperbolic ones.
Abstract: By our definition, "restricted Dirichlet-to-Neumann map" (DN) means that the Dirichlet and Neumann boundary data for a Coefficient Inverse Problem (CIP) are generated by a point source running along an interval of a straight line. On the other hand, the conventional DN data can be generated, at least sometimes, by a point source running along a hypersurface. CIPs with the restricted DN data are non-overdetermined in the $n-$D case with $n \geq 2$. We develop, in a unified way, a general and a radically new numerical concept for CIPs with restricted DN data for a broad class of PDEs of the second order, such as, e.g. elliptic, parabolic and hyperbolic ones. Namely, using Carleman Weight Functions, we construct globally convergent numerical methods. Holder stability and uniqueness are also proved. The price we pay for these features is a well acceptable one in the Numerical Analysis: we truncate a certain Fourier-like series with respect to some functions depending only on the position of that point source. At least three applications are: imaging of land mines, crosswell imaging and electrical impedance tomography.

Posted Content
TL;DR: In this paper, the authors consider sparsity-based techniques for the approximation of high-dimensional functions from random pointwise evaluations, and derive recipes for the optimal choice of the respective tuning parameters.
Abstract: We consider sparsity-based techniques for the approximation of high-dimensional functions from random pointwise evaluations. To date, almost all the works published in this field contain some a priori assumptions about the error corrupting the samples that are hard to verify in practice. In this paper, we instead focus on the scenario where the error is unknown. We study the performance of four sparsity-promoting optimization problems: weighted quadratically-constrained basis pursuit, weighted LASSO, weighted square-root LASSO, and weighted LAD-LASSO. From the theoretical perspective, we prove uniform recovery guarantees for these decoders, deriving recipes for the optimal choice of the respective tuning parameters. On the numerical side, we compare them in the pure function approximation case and in applications to uncertainty quantification of ODEs and PDEs with random inputs. Our main conclusion is that the lesser-known square-root LASSO is better suited for high-dimensional approximation than the other procedures in the case of bounded noise, since it avoids (both theoretically and numerically) the need for parameter tuning.