-
Physics guided machine learning using simplified theories
Authors:
Suraj Pawar,
Omer San,
Burak Aksoylu,
Adil Rasheed,
Trond Kvamsdal
Abstract:
Recent applications of machine learning, in particular deep learning, motivate the need to address the generalizability of the statistical inference approaches in physical sciences. In this letter, we introduce a modular physics guided machine learning framework to improve the accuracy of such data-driven predictive engines. The chief idea in our approach is to augment the knowledge of the simplif…
▽ More
Recent applications of machine learning, in particular deep learning, motivate the need to address the generalizability of the statistical inference approaches in physical sciences. In this letter, we introduce a modular physics guided machine learning framework to improve the accuracy of such data-driven predictive engines. The chief idea in our approach is to augment the knowledge of the simplified theories with the underlying learning process. To emphasise on their physical importance, our architecture consists of adding certain features at intermediate layers rather than in the input layer. To demonstrate our approach, we select a canonical airfoil aerodynamic problem with the enhancement of the potential flow theory. We include features obtained by a panel method that can be computed efficiently for an unseen configuration in our training procedure. By addressing the generalizability concerns, our results suggest that the proposed feature enhancement approach can be effectively used in many scientific machine learning applications, especially for the systems where we can use a theoretical, empirical, or simplified model to guide the learning module.
△ Less
Submitted 18 December, 2020;
originally announced December 2020.
-
Incorporating local boundary conditions into nonlocal theories
Authors:
Burak Aksoylu,
Horst Reinhard Beyer,
Fatih Celiker
Abstract:
We study nonlocal equations from the area of peridynamics on bounded domains. In our companion paper, we discover that, on $\mathbb{R}^n$, the governing operator in peridynamics, which involves a convolution, is a bounded function of the classical (local) governing operator. Building on this, we define an abstract convolution operator on bounded domains. The abstract convolution operator is a func…
▽ More
We study nonlocal equations from the area of peridynamics on bounded domains. In our companion paper, we discover that, on $\mathbb{R}^n$, the governing operator in peridynamics, which involves a convolution, is a bounded function of the classical (local) governing operator. Building on this, we define an abstract convolution operator on bounded domains. The abstract convolution operator is a function of the classical operator, defined by a Hilbert basis available due to the purely discrete spectrum of the latter. As governing operator of the nonlocal equation we use a function of the classical operator, this allows us to incorporate local boundary conditions into nonlocal theories.
For the homogeneous wave equation with the considered boundary conditions, we prove that continuity is preserved by time evolution. We give explicit solution expressions for the initial value problems with prominent boundary conditions such as periodic, antiperiodic, Neumann, and Dirichlet. In order to connect to the standard convolution, we give an integral representation of the abstract convolution operator. We present additional "simple" convolutionsbased on periodic and antiperiodic boundary conditions that lead Neumann and Dirichlet boundary conditions.
We present a numerical study of the solutions of the wave equation. For discretization, we employ a weak formulation based on a Galerkin projection and use piecewise polynomials on each element which allows discontinuities of the approximate solution at the element borders. We study convergence order of solutions with respect to polynomial order and observe optimal convergence. We depict the solutions for each boundary condition.
△ Less
Submitted 12 November, 2014;
originally announced November 2014.
-
On a Class of Nonlocal Wave Equations from Applications
Authors:
Horst Reinhard Beyer,
Burak Aksoylu,
Fatih Celiker
Abstract:
We study equations from the area of peridynamics, which is an extension of elasticity. The governing equations form a system of nonlocal wave equations. Its governing operator is found to be a bounded, linear and self-adjoint operator on a Hilbert space. We study the well-posedness and stability of the associated initial value problem. We solve the initial value problem by applying the f…
▽ More
We study equations from the area of peridynamics, which is an extension of elasticity. The governing equations form a system of nonlocal wave equations. Its governing operator is found to be a bounded, linear and self-adjoint operator on a Hilbert space. We study the well-posedness and stability of the associated initial value problem. We solve the initial value problem by applying the functional calculus of the governing operator. In addition, we give a series representation of the solution in terms of spherical Bessel functions. For the case of scalar valued functions, the governing operator turns out as functions of the Laplace operator. This result enables the comparison of peridynamic solutions to those of classical elasticity as well as the introduction of local boundary conditions into the nonlocal theory. The latter is studied in a companion paper.
△ Less
Submitted 26 September, 2014;
originally announced September 2014.
-
Goal-Oriented Adaptivity and Multilevel Preconditioning for the Poisson-Boltzmann Equation
Authors:
Burak Aksoylu,
Stephen Bond,
Eric Cyr,
Michael Holst
Abstract:
In this article, we develop goal-oriented error indicators to drive adaptive refinement algorithms for the Poisson-Boltzmann equation. Empirical results for the solvation free energy linear functional demonstrate that goal-oriented indicators are not sufficient on their own to lead to a superior refinement algorithm. To remedy this, we propose a problem-specific marking strategy using the solvatio…
▽ More
In this article, we develop goal-oriented error indicators to drive adaptive refinement algorithms for the Poisson-Boltzmann equation. Empirical results for the solvation free energy linear functional demonstrate that goal-oriented indicators are not sufficient on their own to lead to a superior refinement algorithm. To remedy this, we propose a problem-specific marking strategy using the solvation free energy computed from the solution of the linear regularized Poisson-Boltzmann equation. The convergence of the solvation free energy using this marking strategy, combined with goal-oriented refinement, compares favorably to adaptive methods using an energy-based error indicator. Due to the use of adaptive mesh refinement, it is critical to use multilevel preconditioning in order to maintain optimal computational complexity. We use variants of the classical multigrid method, which can be viewed as generalizations of the hierarchical basis multigrid and Bramble-Pasciak-Xu (BPX) preconditioners.
△ Less
Submitted 19 September, 2011;
originally announced September 2011.
-
Local Refinement and Multilevel Preconditioning: Implementation and Numerical Experiments
Authors:
Burak Aksoylu,
Stephen Bond,
Michael Holst
Abstract:
In this paper, we examine a number of additive and multiplicative multilevel iterative methods and preconditioners in the setting of two-dimensional local mesh refinement. While standard multilevel methods are effective for uniform refinement-based discretizations of elliptic equations, they tend to be less effective for algebraic systems which arise from discretizations on locally refined meshe…
▽ More
In this paper, we examine a number of additive and multiplicative multilevel iterative methods and preconditioners in the setting of two-dimensional local mesh refinement. While standard multilevel methods are effective for uniform refinement-based discretizations of elliptic equations, they tend to be less effective for algebraic systems which arise from discretizations on locally refined meshes, losing their optimal behavior in both storage and computational complexity. Our primary focus here is on BPX-style additive and multiplicative multilevel preconditioners, and on various stabilizations of the additive and multiplicative hierarchical basis method (HB), and their use in the local mesh refinement setting. In this article, we describe in detail the implementation of these types of algorithms, including detailed discussions of the datastructures and traversal algorithms we employ for obtaining optimal storage and computational complexity in our implementations. We show how each of the algorithms can be implemented using standard datatypes available in languages such as C and FORTRAN, so that the resulting algorithms have optimal (linear) storage requirements, and so that the resulting multilevel method or preconditioner can be applied with optimal (linear) computational costs. Our implementations are performed in both C and MATLAB using the Finite Element ToolKit (FETK), an open source finite element software package. We finish the paper with a sequence of numerical experiments illustrating the effectiveness of a number of BPX and stabilized HB variants for several examples requiring local refinement.
△ Less
Submitted 8 January, 2010;
originally announced January 2010.
-
Optimality of multilevel preconditioners for local mesh refinement in three dimensions
Authors:
Burak Aksoylu,
Michael Holst
Abstract:
In this article, we establish optimality of the Bramble-Pasciak-Xu (BPX) norm equivalence and optimality of the wavelet modified (or stabilized) hierarchical basis (WHB) preconditioner in the setting of local 3D mesh refinement. In the analysis of WHB methods, a critical first step is to establish the optimality of BPX norm equivalence for the refinement procedures under consideration. While the…
▽ More
In this article, we establish optimality of the Bramble-Pasciak-Xu (BPX) norm equivalence and optimality of the wavelet modified (or stabilized) hierarchical basis (WHB) preconditioner in the setting of local 3D mesh refinement. In the analysis of WHB methods, a critical first step is to establish the optimality of BPX norm equivalence for the refinement procedures under consideration. While the available optimality results for the BPX norm have been constructed primarily in the setting of uniformly refined meshes, a notable exception is the local 2D red-green result due to Dahmen and Kunoth. The purpose of this article is to extend this original 2D optimality result to the local 3D red-green refinement procedure introduced by Bornemann-Erdmann-Kornhuber (BEK), and then to use this result to extend the WHB optimality results from the quasiuniform setting to local 2D and 3D red-green refinement scenarios. The BPX extension is reduced to establishing that locally enriched finite element subspaces allow for the construction of a scaled basis which is formally Riesz stable. It is possible to show that the number of degrees of freedom used for smoothing is bounded by a constant times the number of degrees of freedom introduced at that level of refinement, indicating that a practical implementable version of the resulting BPX preconditioner for the BEK refinement setting has provably optimal (linear) computational complexity per iteration. An interesting implication of the optimality of the WHB preconditioner is the a priori H1-stability of the L2-projection. The theoretical framework employed supports arbitrary spatial dimension d >= 1 and requires no coefficient smoothness assumptions beyond those required for well-posedness in H1.
△ Less
Submitted 8 January, 2010;
originally announced January 2010.
-
Robust multigrid preconditioners for the high-contrast biharmonic plate equation
Authors:
Burak Aksoylu,
Zuhal Yeter
Abstract:
We study the high-contrast biharmonic plate equation with HCT and Morley discretizations. We construct a preconditioner that is robust with respect to contrast size and mesh size simultaneously based on the preconditioner proposed by Aksoylu et al. (2008, Comput. Vis. Sci. 11, pp. 319--331). By extending the devised singular perturbation analysis from linear finite element discretization to the…
▽ More
We study the high-contrast biharmonic plate equation with HCT and Morley discretizations. We construct a preconditioner that is robust with respect to contrast size and mesh size simultaneously based on the preconditioner proposed by Aksoylu et al. (2008, Comput. Vis. Sci. 11, pp. 319--331). By extending the devised singular perturbation analysis from linear finite element discretization to the above discretizations, we prove and numerically demonstrate the robustness of the preconditioner. Therefore, we accomplish a desirable preconditioning design goal by using the same family of preconditioners to solve elliptic family of PDEs with varying discretizations. We also present a strategy on how to generalize the proposed preconditioner to cover high-contrast elliptic PDEs of order $2k, k>2$. Moreover, we prove a fundamental qualitative property of solution of the high-contrast biharmonic plate equation. Namely, the solution over the highly-bending island becomes a linear polynomial asymptotically. The effectiveness of our preconditioner is largely due to the integration of this qualitative understanding of the underlying PDE into its construction.
△ Less
Submitted 2 October, 2009;
originally announced October 2009.
-
Variational Theory and Domain Decomposition for Nonlocal Problems
Authors:
Burak Aksoylu,
Michael L. Parks
Abstract:
In this article we present the first results on domain decomposition methods for nonlocal operators. We present a nonlocal variational formulation for these operators and establish the well-posedness of associated boundary value problems, proving a nonlocal Poincaré inequality. To determine the conditioning of the discretized operator, we prove a spectral equivalence which leads to a mesh size ind…
▽ More
In this article we present the first results on domain decomposition methods for nonlocal operators. We present a nonlocal variational formulation for these operators and establish the well-posedness of associated boundary value problems, proving a nonlocal Poincaré inequality. To determine the conditioning of the discretized operator, we prove a spectral equivalence which leads to a mesh size independent upper bound for the condition number of the stiffness matrix. We then introduce a nonlocal two-domain variational formulation utilizing nonlocal transmission conditions, and prove equivalence with the single-domain formulation. A nonlocal Schur complement is introduced. We establish condition number bounds for the nonlocal stiffness and Schur complement matrices. Supporting numerical experiments demonstrating the conditioning of the nonlocal one- and two-domain problems are presented.
△ Less
Submitted 8 January, 2011; v1 submitted 24 September, 2009;
originally announced September 2009.
-
Robust multigrid preconditioners for cell-centered finite volume discretization of the high-contrast diffusion equation
Authors:
Burak Aksoylu,
Zuhal Yeter
Abstract:
We study a conservative 5-point cell-centered finite volume discretization of the high-contrast diffusion equation. We aim to construct preconditioners that are robust with respect to the magnitude of the coefficient contrast and the mesh size simultaneously. For that, we prove and numerically demonstrate the robustness of the preconditioner proposed by Aksoylu et al. (2008, Comput. Vis. Sci. 11…
▽ More
We study a conservative 5-point cell-centered finite volume discretization of the high-contrast diffusion equation. We aim to construct preconditioners that are robust with respect to the magnitude of the coefficient contrast and the mesh size simultaneously. For that, we prove and numerically demonstrate the robustness of the preconditioner proposed by Aksoylu et al. (2008, Comput. Vis. Sci. 11, pp. 319--331) by extending the devised singular perturbation analysis from linear finite element discretization to the above discretization. The singular perturbation analysis is more involved than that of finite element because all the subblocks in the discretization matrix depend on the diffusion coefficient. However, that dependence is eliminated asymptotically. This allows the same preconditioner to be utilized due to similar limiting behaviours of the submatrices; leading to a narrowing family of preconditioners that can be used for different discretizations--a desirable preconditioner design goal. We compare our numerical results to standard cell-centered multigrid and observe that performance of our preconditioner is independent of the utilized prolongation operators and smoothers.
As a side result, we also prove that the solution over the highly-diffusive island becomes constant asymptotically. Integration of this qualitative understanding of the underlying PDE to our preconditioner is the main reason behind its superior performance. Diagonal scaling is probably the most basic preconditioner for high-contrast coefficients. Extending the matrix entry based spectral analysis introduced by Graham and Hagger, we rigorously show that the number of small eigenvalues of the diagonally scaled matrix depends on the number of isolated islands comprising the highly-diffusive region.
△ Less
Submitted 12 April, 2009;
originally announced April 2009.
-
On the characterization of asymptotic cases of the diffusion equation with rough coefficients and applications to preconditioning
Authors:
Burak Aksoylu,
Horst R. Beyer
Abstract:
We consider the diffusion equation in the setting of operator theory. In particular, we study the characterization of the limit of the diffusion operator for diffusivities approaching zero on a subdomain $Ω_1$ of the domain of integration of $Ω$. We generalize Lions' results to covering the case of diffusivities which are piecewise $C^1$ up to the boundary of $Ω_1$ and $Ω_2$, where…
▽ More
We consider the diffusion equation in the setting of operator theory. In particular, we study the characterization of the limit of the diffusion operator for diffusivities approaching zero on a subdomain $Ω_1$ of the domain of integration of $Ω$. We generalize Lions' results to covering the case of diffusivities which are piecewise $C^1$ up to the boundary of $Ω_1$ and $Ω_2$, where $Ω_2 := Ω\setminus \overlineΩ_1$ instead of piecewise constant coefficients. In addition, we extend both Lions' and our previous results by providing the strong convergence of $(A_{\bar{p}_ν}^{-1})_{ν\in \mathbb{N}^\ast},$ for a monotonically decreasing sequence of diffusivities $(\bar{p}_ν)_{ν\in \mathbb{N}^\ast}$.
△ Less
Submitted 4 February, 2009;
originally announced February 2009.
-
Results on the diffusion equation with rough coefficients
Authors:
Burak Aksoylu,
Horst R. Beyer
Abstract:
We study the behaviour of the solutions of the stationary diffusion equation as a function of a possibly rough ($L^{\infty}$-) diffusivity. This includes the boundary behaviour of the solution maps, associating to each diffusivity the solution corresponding to some fixed source function, when the diffusivity approaches infinite values in parts of the medium. In $n$-dimensions, $n \geq 1$, by ass…
▽ More
We study the behaviour of the solutions of the stationary diffusion equation as a function of a possibly rough ($L^{\infty}$-) diffusivity. This includes the boundary behaviour of the solution maps, associating to each diffusivity the solution corresponding to some fixed source function, when the diffusivity approaches infinite values in parts of the medium. In $n$-dimensions, $n \geq 1$, by assuming a weak notion of convergence on the set of diffusivities, we prove the strong sequential continuity of the solution maps. In 1-dimension, we prove a stronger result, i.e., the unique extendability of the map of solution operators, associating to each diffusivity the corresponding solution operator, to a sequentially continuous map in the operator norm on a set containing `diffusivities' assuming infinite values in parts of the medium. In this case, we also give explicit estimates on the convergence behaviour of the map.
△ Less
Submitted 19 October, 2008;
originally announced October 2008.
-
Generating Initial Data in General Relativity using Adaptive Finite Element Methods
Authors:
Burak Aksoylu,
David Bernstein,
Stephen Bond,
Michael Holst
Abstract:
The conformal formulation of the Einstein constraint equations is first reviewed, and we then consider the design, analysis, and implementation of adaptive multilevel finite element-type numerical methods for the resulting coupled nonlinear elliptic system. We derive weak formulations of the coupled constraints, and review some new developments in the solution theory for the constraints in the c…
▽ More
The conformal formulation of the Einstein constraint equations is first reviewed, and we then consider the design, analysis, and implementation of adaptive multilevel finite element-type numerical methods for the resulting coupled nonlinear elliptic system. We derive weak formulations of the coupled constraints, and review some new developments in the solution theory for the constraints in the cases of constant mean extrinsic curvature (CMC) data, near-CMC data, and arbitrarily prescribed mean extrinsic curvature data. We then outline some recent results on a priori and a posteriori error estimates for a broad class of Galerkin-type approximation methods for this system which includes techniques such as finite element, wavelet, and spectral methods. We then use these estimates to construct an adaptive finite element method (AFEM) for solving this system numerically, and outline some new convergence and optimality results. We then describe in some detail an implementation of the methods using the FETK software package, which is an adaptive multilevel finite element code designed to solve nonlinear elliptic and parabolic systems on Riemannian manifolds. We finish by describing a simplex mesh generation algorithm for compact binary objects, and then look at a detailed example showing the use of FETK for numerical solution of the constraints.
△ Less
Submitted 7 April, 2009; v1 submitted 21 January, 2008;
originally announced January 2008.
-
Solving the Einstein constraint equations on multi-block triangulations using finite element methods
Authors:
Oleg Korobkin,
Burak Aksoylu,
Michael Holst,
Enrique Pazos,
Manuel Tiglio
Abstract:
In order to generate initial data for nonlinear relativistic simulations, one needs to solve the Einstein constraints, which can be cast into a coupled set of nonlinear elliptic equations. Here we present an approach for solving these equations on three-dimensional multi-block domains using finite element methods. We illustrate our approach on a simple example of Brill wave initial data, with th…
▽ More
In order to generate initial data for nonlinear relativistic simulations, one needs to solve the Einstein constraints, which can be cast into a coupled set of nonlinear elliptic equations. Here we present an approach for solving these equations on three-dimensional multi-block domains using finite element methods. We illustrate our approach on a simple example of Brill wave initial data, with the constraints reducing to a single linear elliptic equation for the conformal factor $ψ$. We use quadratic Lagrange elements on semi-structured simplicial meshes, obtained by triangulation of multi-block grids. In the case of uniform refinement the scheme is superconvergent at most mesh vertices, due to local symmetry of the finite element basis with respect to local spatial inversions. We show that in the superconvergent case subsequent unstructured mesh refinements do not improve the quality of our initial data. As proof of concept that this approach is feasible for generating multi-block initial data in three dimensions, after constructing the initial data we evolve them in time using a high order finite-differencing multi-block approach and extract the gravitational waves from the numerical solution.
△ Less
Submitted 3 June, 2009; v1 submitted 11 January, 2008;
originally announced January 2008.