Frédéric Magoulès

Frédéric Magoulès
CentraleSupélec | ECP

BSc, MSc, PhD

About

346
Publications
28,340
Reads
How we measure 'reads'
A 'read' is counted each time someone views a publication summary (such as the title, abstract, and list of authors), clicks on a figure, or views or downloads the full-text. Learn more
6,142
Citations

Publications

Publications (346)
Article
The recent rise of deep learning has led to numerous applications, including solving partial differential equations using Physics-Informed Neural Networks. This approach has proven highly effective in several academic cases. However, their lack of physical invariances, coupled with other significant weaknesses, such as an inability to handle comple...
Article
Full-text available
This article presents the asynchronous global-local non-invasive coupling in the case of nonlinear monotone patches as encountered when inserting elastoplastic components in a global linear elastic model. The convergence of the method is theoretically established in a general framework using the paracontractions technique and illustrated in academi...
Preprint
Full-text available
The recent rise of deep learning has led to numerous applications, including solving partial differential equations using Physics-Informed Neural Networks. This approach has proven highly effective in several academic cases. However, their lack of physical invariances, coupled with other significant weaknesses, such as an inability to handle comple...
Preprint
In the framework of the optimal wave energy absorption, we solve theoretically and numerically a parametric shape optimization problem to find the optimal distribution of absorbing material in the reflexive one defined by a characteristic function in the Robin-type boundary condition associated with the Helmholtz equation. Robin boundary condition...
Chapter
Metal forging is used to manufacture dies. We require the best set of input parameters for the process to be efficient. Currently, we predict the best parameters using the finite element method by generating simulations for the different initial conditions, which is a time-consuming process.In this paper, introduce a hybrid approach that helps in p...
Conference Paper
Since the seminal work of (M. Raissi et. al.) and their Physics-Informed neural networks (PINNs), many efforts have been conducted towards solving partial differential equations (PDEs) with Deep Learning models. However, some challenges remain, for instance the extension of such models to complex three-dimensional geometries, and a study on how suc...
Article
This paper presents a new scalable asynchronous domain decomposition method which significantly outperforms the recent two-level asynchronous restricted additive Schwarz (RAS) method. The novel approach consists of considering the classical primal Schur complement framework and solving the interface problem using a multisplitting relaxation based o...
Article
This paper introduces a non-overlapping counterpart of the recently achieved two-level asynchronous restricted additive Schwarz (AsyncRAS) solver. It improves the asynchronous additive coarse-space correction therein designed and combines it with another recent asynchronous substructuring method by reformulating it under multisplitting iterative sc...
Preprint
Full-text available
In this paper, we explore point-cloud based deep learning models to analyze numerical simulations arising from finite element analysis. The objective is to classify automatically the results of the simulations without tedious human intervention. Two models are here presented: the Point-Net classification model and the Dynamic Graph Convolutional Ne...
Preprint
Full-text available
This paper presents the first asynchronous version of the Global/Local non-invasive coupling, capable of dealing efficiently with multiple, possibly adjacent, patches. We give a new interpretation of the coupling in terms of primal domain decomposition method, and we prove the convergence of the relaxed asynchronous iteration. The asynchronous para...
Preprint
Full-text available
Current simulation of metal forging processes use advanced finite element methods. Such methods consist of solving mathematical equations, which takes a significant amount of time for the simulation to complete. Computational time can be prohibitive for parametric response surface exploration tasks. In this paper, we propose as an alternative, a Gr...
Preprint
Full-text available
Many Partial Differential Equations (PDEs) do not have analytical solution, and can only be solved by numerical methods. In this context, Physics-Informed Neural Networks (PINN) have become important in the last decades, since it uses a neural network and physical conditions to approximate any functions. This paper focuses on hypertuning of a PINN,...
Preprint
Full-text available
The Global-Local non-invasive coupling is an improvement of the submodeling technique, which permits to locally enhance structure computations by introducing patches with refined models and to take into accounts all the interactions. In order to circumvent its inherently limited computational performance, we propose and implement an asynchronous ve...
Preprint
Full-text available
An asynchronous parallel version of the non-intrusive global-local coupling is implemented. The case of many patches, including those covering the entire structure, is studied. The asynchronism limits the dependency on communications, failures, and load imbalance. We detail the method and illustrate its performance in an academic case.
Preprint
Full-text available
In this paper, we address the problem of designing a distributed application meant to run both classical and asynchronous iterations. MPI libraries are very popular and widely used in the scientific community, however asynchronous iterative methods raise non-negligible difficulties about the efficient management of communication requests and buffer...
Preprint
Full-text available
In this paper, we address the problem of detecting the moment when an ongoing asynchronous parallel iterative process can be terminated to provide a sufficiently precise solution to a fixed-point problem being solved. Formulating the detection problem as a global solution identification problem, we analyze the snapshot-based approach, which is the...
Article
Full-text available
A general asynchronous alternating iterative model is designed, for which convergence is theoretically ensured both under classical spectral radius bound and, then, for a classical class of matrix splittings for H-matrices. The computational model can be thought of as a two-stage alternating iterative method, which well suits to the well-known Herm...
Preprint
Full-text available
This paper deals with linear algebra operations on Graphics Processing Unit (GPU) with complex number arithmetic using double precision. An analysis of their uses within iterative Krylov methods is presented to solve acoustic problems. Numerical experiments performed on a set of acoustic matrices arising from the modelisation of acoustic phenomena...
Preprint
Full-text available
In this paper, we aim to introduce a new perspective when comparing highly parallelized algorithms on GPU: the energy consumption of the GPU. We give an analysis of the performance of linear algebra operations, including addition of vectors, element-wise product, dot product and sparse matrix-vector product, in order to validate our experimental pr...
Preprint
Full-text available
This paper gives an analysis and an evaluation of linear algebra operations on Graphics Processing Unit (GPU) with complex number arithmetics with double precision. Knowing the performance of these operations, iterative Krylov methods are considered to solve the acoustic problem efficiently. Numerical experiments carried out on a set of acoustic ma...
Preprint
Full-text available
Low order, sequential or non-massively parallel finite elements are generaly used for three-dimensional gravity modelling. In this paper, in order to obtain better gravity anomaly solutions in heterogeneous media, we solve the gravimetry problem using massively parallel high order finite elements on hybrid multi-CPU/GPU clusters. Parallel algorithm...
Preprint
Full-text available
In this paper, we present, evaluate and analyse the performance of parallel synchronous Jacobi algorithms by different partitioned procedures including band-row splitting, band-row sparsity pattern splitting and substructuring splitting, when solving sparse large linear systems. Numerical experiments performed on a set of academic 3D Laplace equati...
Preprint
Full-text available
In this paper, the authors propose an analysis of the frequency response function in a car compartment, subject to some fluctuating pressure distribution along the open cavity of the sun-roof at the top of a car. Coupling of a computational fluid dynamics and of a computational acoustics code is considered to simulate the acoustic fluid-structure i...
Preprint
Full-text available
Asynchronous iterations are more and more investigated for both scaling and fault-resilience purpose on high performance computing platforms. While so far, they have been exclusively applied within space domain decomposition frameworks, this paper advocates a novel application direction targeting time-decomposed time-parallel approaches. Specifical...
Preprint
Full-text available
A conventional study of fluid simulation involves different stages including conception, simulation, visualization, and analysis tasks. It is, therefore, necessary to switch between different software and interactive contexts which implies costly data manipulation and increases the time needed for decision making. Our interactive simulation approac...
Preprint
Due to their highly parallel multi-cores architecture, GPUs are being increasingly used in a wide range of computationally intensive applications. Compared to CPUs, GPUs can achieve higher performances at accelerating the programs' execution in an energy-efficient way. Therefore GPGPU computing is useful for high performance computing applications...
Conference Paper
A conventional study of fluid simulation involves different stages including conception, simulation, visualization, and analysis tasks. It is, therefore, necessary to switch between different software and interactive contexts which implies costly data manipulation and increases the time needed for decision making. Our interactive simulation approac...
Preprint
The main objective of this work consists in analyzing sub-structuring method for the parallel solution of sparse linear systems with matrices arising from the discretization of partial differential equations such as finite element, finite volume and finite difference. With the success encountered by the general-purpose processing on graphics proces...
Article
Full-text available
Until now, almost all investigations of asynchronous iterations within domain decomposition frameworks targeted methods of the parallel Schwarz type. A first, and sole, attempt to deal with a primal substructuring framework resulted in an asynchronous substructuring method where relaxation occurs simultaneously on the subdomains and on the interfac...
Article
We consider shape optimization problems for elasticity systems in architecture. A typical objective in this context is to identify a structure of maximal stability that is close to an initially proposed one. For structures without external forces on varying parts classical methods allow to prove the existence of optimal shapes within well-known cla...
Article
Full-text available
Laplace transform method has proved to be very efficient and easy to parallelize for the solution of time-dependent problems. However, the synchronization delay among processors implies an upper bound on the expectable acceleration factor, which leads to a lot of wasted time. In this paper, we propose an original asynchronous Laplace transform meth...
Article
Full-text available
The performance of gradient methods has been considerably improved by the introduction of delayed parameters. Recently, the revealing of second-order information has given rise to the Cauchy-based methods with alignment, which are generally considered as the state of the art of gradient methods. This paper investigates the spectral properties of mi...
Article
Full-text available
In the aim to find the simplest and most efficient shape of a noise absorbing wall to dissipate the acoustical energy of a sound wave, we consider a frequency model described by the Helmholtz equation with a damping on the boundary. The well-posedness of the model is shown in a class of domains with $d$-set boundaries ($N-1\le d<N$). We introduce a...
Preprint
We consider shape optimization problems for elasticity systems in architecture. A typical question in this context is to identify a structure of maximal stability close to an initially proposed one. We show the existence of such an optimally shaped structure within classes of bounded Lipschitz domains and within wider classes of bounded uniform dom...
Article
Full-text available
Compared with arithmetic operation, communication cost is often the bottleneck on modern computers, and thus should be paid increasing attention when choosing algorithms. Lagged gradient methods are known for their error tolerance and fast convergence. However, it appears that their parallel behavior is not well understood. In this paper, we explor...
Article
Full-text available
This article presents enhancement strategies for the Hermitian and skew‐Hermitian splitting method based on gradient iterations. The spectral properties are exploited for the parameter estimation, often resulting in a better convergence. In particular, steepest descent with early stopping can generate a rough estimate of the optimal upper bound. Th...
Article
In this paper, we tackled the convergence detection problem arisen from the absence of synchronization during asynchronous iterative computation. We showed that, when one arbitrarily takes the local components of a global solution vector, an upper bound can be established on the difference between a residual error evaluated from this global vector...
Preprint
In the aim to find the simplest and most efficient shape of a noise absorbing wall to dissipate the acoustical energy of a sound wave, we consider a frequency model described by the Helmholtz equation with a damping on the boundary. The well-posedness of the model is shown in a class of domains with $d$-set boundaries ($N-1\le d<N$). We introduce a...
Article
Full-text available
Background Bariatric surgery is an effective therapeutic procedure for morbidly obese patients. The two most common interventions are Sleeve Gastrectomy (SG) and Laparoscopic Roux-en-Y Gastric Bypass (LRYGB). Objectives The aim of this study was to compare microbiome long-term microbiome after SG and LRYGB surgery in obese patients. Setting Unive...
Preprint
In this paper we present an effective coarse space correction addressed to accelerate the solution of an algebraic linear system. The system arises from the formulation of the problem of interpolating scattered data by means of Radial Basis Functions. Radial Basis Functions are commonly used for interpolating scattered data during the image reconst...
Preprint
This paper covers the fast solution of large acoustic problems on low-resources parallel platforms. A domain decomposition method is coupled with a dynamic load balancing scheme to efficiently accelerate a geometrical acoustic method. The geometrical method studied implements a beam-tracing method where intersections are handled as in a ray-tracing...
Preprint
Full-text available
In the context of a virtual reconstitution of the destroyed Royaumont abbey church, this paper investigates computer sciences issues intrinsic to the physically-based image rendering. First, a virtual model was designed from historical sources and archaeological descriptions. Then some materials physical properties were measured on remains of the c...
Preprint
Full-text available
This paper describes a work in progress about software and hardware architecture to steer and control an ongoing fluid simulation in a context of a serious game application. We propose to use the Lattice Boltzmann Method as the simulation approach considering that it can provide fully parallel algorithms to reach interactive time and because it is...
Preprint
Full-text available
This paper discusses about the advantage of using asynchronous simulation in the case of interactive simulation in which user can steer and control parameters during a simulation in progress. synchronous models allow to compute each iteration faster to address the issues of performance needed in an highly interactive context, and our hypothesis is...
Preprint
Full-text available
In this paper, we use an original ray-tracing domain decomposition method to address image rendering of naturally lighted scenes. This new method allows to particularly analyze rendering problems on parallel architectures, in the case of interactions between light-rays and glass material. Numerical experiments, for medieval glass rendering within t...
Preprint
Full-text available
This paper covers the time consuming issues intrinsic to physically-based image rendering algorithms. First, glass materials optical properties were measured on samples of real glasses and other objects materials inside an hotel room were characterized by deducing spectral data from multiple trichromatic images. We then present the rendering model...
Article
Convergence of both synchronous and asynchronous optimized Schwarz algorithms for the shifted Laplacian operator on a bounded rectangular domain, in a one‐way subdivision of the computational domain, with overlap, is shown. Convergence results are obtained under very mild conditions on the size of the subdomains and on the amount of overlap. A coup...
Preprint
On modern parallel architectures, the cost of synchronization among processors can often dominate the cost of floating-point computation. Several modifications of the existing methods have been proposed in order to keep the communication cost as low as possible. This paper aims at providing a brief overview of recent advances in parallel iterative...
Preprint
We present some extensions to the limited memory steepest descent method based on spectral properties and cyclic iterations. Our aim is to show that it is possible to combine sweep and delayed strategies for improving the performance of gradient methods. Numerical results are reported which indicate that our new methods are better than the original...
Preprint
Full-text available
The performance of gradient methods has been considerably improved by the introduction of delayed parameters. After two and a half decades, the revealing of second-order information has recently given rise to the Cauchy-based methods with alignment, which reduce asymptotically the search spaces in smaller and smaller dimensions. They are generally...
Preprint
Full-text available
This paper presents enhancement strategies for the Hermitian and skew-Hermitian splitting method based on gradient iterations. The spectral properties are exploited for the parameter estimation, often resulting in a better convergence. In particular, steepest descent with early stopping can generate a rough estimate of the optimal parameter. This i...
Preprint
Full-text available
Laplace transform method has proved to be very efficient and easy to parallelize for the solution of time-dependent problems. However, the synchronization delay among processors implies an upper bound on the expectable acceleration factor, which leads to a lot of wasted time. In this paper, we propose an original asynchronous Laplace transform meth...
Article
Asynchronous iterations have been investigated more and more for both scaling and fault-resilience purposes on high performance computing platforms. While so far, they have been exclusively applied within space domain decomposition frameworks, this paper advocates a novel application direction targeting time-decomposed time-parallel approaches. Spe...
Preprint
Full-text available
This paper addresses the distributed convergence detection problem in asynchronous iterations. A modified recursive doubling algorithm is investigated in order to adapt to the non-power-of-two case. Some convergence detection algorithms are illustrated based on the reduction operation. Finally, a concluding discussion about the implementation and t...
Preprint
Full-text available
This paper proposes a new gradient method to solve the large-scale problems. Theoretical analysis shows that the new method has finite termination property for two dimensions and converges R-linearly for any dimensions. Experimental results illustrate first the issue of parallel implementation. Then, the solution of a large-scale problem shows that...
Article
Full-text available
Motivation: Analysis toolkits for shotgun metagenomic data achieve strain-level characterization of complex microbial communities by capturing intra-species gene content variation. Yet, these tools are hampered by the extent of reference genomes that are far from covering all microbial variability, as many species are still not sequenced or have o...
Preprint
Full-text available
Background: Bariatric surgery is an effective therapeutic procedure for morbidly obese patients as it induces sustained weight loss. The two most common interventions are Laparoscopic Sleeve Gastrectomy (LSG) and Laparoscopic Roux-en-Y Gastric Bypass(LRYGB). Objective: Characterizing the gut microbiota changes induced by LSG and LRYGB. Design: 89 a...
Article
Presents corrections to the paper, “K nearest neighbour joins for big data on MapReduce: A theoretical and experimental analysis,” (Song, G., et al), IEEE Trans. Knowl. Data Eng., vol. 28, no. 9, pp. 2376–2392, Sep. 2016.
Preprint
Full-text available
Motivation Analysis toolkits for shotgun metagenomic data achieve strain-level characterization of complex microbial communities by capturing intra-species gene content variation. Yet, these tools are hampered by the extent of reference genomes that are far from covering all microbial variability, as many species are still not sequenced or have onl...
Article
Full-text available
Spatial domain decomposition methods have been largely investigated in the last decades, while time domain decomposition seems to be contrary to intuition and so is not as popular as the former. However, many attractive methods have been proposed, especially the parareal algorithm, which showed both theoretical and experimental efficiency in the co...
Article
Galerkin/least-squares and Galerkin gradient/least-squares stand out among several approaches designed to improve the numerical solution accuracy and counteract the pollution effect by adding terms to the standard Galerkin formulation. These added terms are multiplied by a ‘stability parameter’ which must be properly defined. In this paper, an orig...
Article
Complex-valued Helmholtz equations arise in various applications, and a lot of research has been devoted to finding efficient preconditioners for the iterative solution of their discretizations. In this paper we consider the Helmholtz equation rewritten in real-valued block form, and use a preconditioner in a special two-by-two block form. We show...
Article
In this paper, we address the design of a communication library which particularly targets distributed iterative computing, including randomly executed asynchronous iterations. The well-known MPI programming framework is considered, upon which unique generic routines are proposed for both blocking and non-blocking communication modes. This allows f...
Chapter
A convergence proof of Asynchronous Optimized Schwarz Methods applied to a shifted Laplacian problem, with negative shift, in \(\mathbb {R}^2\) is presented. Sufficient conditions for convergence involving initial values of the approximation of the solution are discussed.
Chapter
An analysis of the convergence properties of Optimized Schwarz methods applied as solvers for Poisson’s Equation in a bounded rectangular domain with Dirichlet (physical) boundary conditions and Robin transmission conditions on the artificial boundaries is presented. To our knowledge this is the first time that this is done for multiple subdomains...