-
High-performance finite elements with MFEM
Authors:
Julian Andrej,
Nabil Atallah,
Jan-Phillip Bäcker,
John Camier,
Dylan Copeland,
Veselin Dobrev,
Yohann Dudouit,
Tobias Duswald,
Brendan Keith,
Dohyun Kim,
Tzanio Kolev,
Boyan Lazarov,
Ketan Mittal,
Will Pazner,
Socratis Petrides,
Syun'ichi Shiraiwa,
Mark Stowell,
Vladimir Tomov
Abstract:
The MFEM (Modular Finite Element Methods) library is a high-performance C++ library for finite element discretizations. MFEM supports numerous types of finite element methods and is the discretization engine powering many computational physics and engineering applications across a number of domains. This paper describes some of the recent research and development in MFEM, focusing on performance p…
▽ More
The MFEM (Modular Finite Element Methods) library is a high-performance C++ library for finite element discretizations. MFEM supports numerous types of finite element methods and is the discretization engine powering many computational physics and engineering applications across a number of domains. This paper describes some of the recent research and development in MFEM, focusing on performance portability across leadership-class supercomputing facilities, including exascale supercomputers, as well as new capabilities and functionality, enabling a wider range of applications. Much of this work was undertaken as part of the Department of Energy's Exascale Computing Project (ECP) in collaboration with the Center for Efficient Exascale Discretizations (CEED).
△ Less
Submitted 24 February, 2024;
originally announced February 2024.
-
Mixed-Order Meshes through rp-adaptivity for Surface Fitting to Implicit Geometries
Authors:
Ketan Mittal,
Veselin A. Dobrev,
Patrick Knupp,
Tzanio Kolev,
Franck Ledoux,
Claire Roche,
Vladimir Z. Tomov
Abstract:
Computational analysis with the finite element method requires geometrically accurate meshes. It is well known that high-order meshes can accurately capture curved surfaces with fewer degrees of freedom in comparison to low-order meshes. Existing techniques for high-order mesh generation typically output meshes with same polynomial order for all elements. However, high order elements away from cur…
▽ More
Computational analysis with the finite element method requires geometrically accurate meshes. It is well known that high-order meshes can accurately capture curved surfaces with fewer degrees of freedom in comparison to low-order meshes. Existing techniques for high-order mesh generation typically output meshes with same polynomial order for all elements. However, high order elements away from curvilinear boundaries or interfaces increase the computational cost of the simulation without increasing geometric accuracy. In prior work, we have presented one such approach for generating body-fitted uniform-order meshes that takes a given mesh and morphs it to align with the surface of interest prescribed as the zero isocontour of a level-set function. We extend this method to generate mixed-order meshes such that curved surfaces of the domain are discretized with high-order elements, while low-order elements are used elsewhere. Numerical experiments demonstrate the robustness of the approach and show that it can be used to generate mixed-order meshes that are much more efficient than high uniform-order meshes. The proposed approach is purely algebraic, and extends to different types of elements (quadrilaterals/triangles/tetrahedron/hexahedra) in two- and three-dimensions.
△ Less
Submitted 29 January, 2024;
originally announced January 2024.
-
A High-Order Shifted Interface Method for Lagrangian Shock Hydrodynamics
Authors:
Nabil M. Atallah,
Ketan Mittal,
Guglielmo Scovazzi,
Vladimir Z. Tomov
Abstract:
We present a new method for two-material Lagrangian hydrodynamics, which combines the Shifted Interface Method (SIM) with a high-order Finite Element Method. Our approach relies on an exact (or sharp) material interface representation, that is, it uses the precise location of the material interface. The interface is represented by the zero level-set of a continuous high-order finite element functi…
▽ More
We present a new method for two-material Lagrangian hydrodynamics, which combines the Shifted Interface Method (SIM) with a high-order Finite Element Method. Our approach relies on an exact (or sharp) material interface representation, that is, it uses the precise location of the material interface. The interface is represented by the zero level-set of a continuous high-order finite element function that moves with the material velocity. This strategy allows to evolve curved material interfaces inside curved elements. By reformulating the original interface problem over a surrogate (approximate) interface, located in proximity of the true interface, the SIM avoids cut cells and the associated problematic issues regarding implementation, numerical stability, and matrix conditioning. Accuracy is maintained by modifying the original interface conditions using Taylor expansions. We demonstrate the performance of the proposed algorithms on established numerical benchmarks in one, two and three dimensions.
△ Less
Submitted 21 September, 2023;
originally announced September 2023.
-
Weak Boundary Conditions for Lagrangian Shock Hydrodynamics: A High-Order Finite Element Implementation on Curved Boundaries
Authors:
Nabil M. Atallah,
Vladimir Z. Tomov,
Guglielmo Scovazzi
Abstract:
We propose a new Nitsche-type approach for weak enforcement of normal velocity boundary conditions for a Lagrangian discretization of the compressible shock-hydrodynamics equations using high-order finite elements on curved boundaries. Specifically, the variational formulation is appropriately modified to enforce free-slip wall boundary conditions, without perturbing the structure of the function…
▽ More
We propose a new Nitsche-type approach for weak enforcement of normal velocity boundary conditions for a Lagrangian discretization of the compressible shock-hydrodynamics equations using high-order finite elements on curved boundaries. Specifically, the variational formulation is appropriately modified to enforce free-slip wall boundary conditions, without perturbing the structure of the function spaces used to represent the solution, with a considerable simplification with respect to traditional approaches. Total energy is conserved and the resulting mass matrices are constant in time. The robustness and accuracy of the proposed method are validated with an extensive set of tests involving nontrivial curved boundaries.
△ Less
Submitted 1 September, 2023;
originally announced September 2023.
-
High-Order Mesh Morphing for Boundary and Interface Fitting to Implicit Geometries
Authors:
Jorge-Luis Barrera,
Tzanio Kolev,
Ketan Mittal,
Vladimir Tomov
Abstract:
We propose a method that morphs high-orger meshes such that their boundaries and interfaces coincide/align with implicitly defined geometries. Our focus is particularly on the case when the target surface is prescribed as the zero isocontour of a smooth discrete function. Common examples of this scenario include using level set functions to represent material interfaces in multimaterial configurat…
▽ More
We propose a method that morphs high-orger meshes such that their boundaries and interfaces coincide/align with implicitly defined geometries. Our focus is particularly on the case when the target surface is prescribed as the zero isocontour of a smooth discrete function. Common examples of this scenario include using level set functions to represent material interfaces in multimaterial configurations, and evolving geometries in shape and topology optimization. The proposed method formulates the mesh optimization problem as a variational minimization of the sum of a chosen mesh-quality metric using the Target-Matrix Optimization Paradigm (TMOP) and a penalty term that weakly forces the selected faces of the mesh to align with the target surface. The distinct features of the method are use of a source mesh to represent the level set function with sufficient accuracy, and adaptive strategies for setting the penalization weight and selecting the faces of the mesh to be fit to the target isocontour of the level set field. We demonstrate that the proposed method is robust for generating boundary- and interface-fitted meshes for curvilinear domains using different element types in 2D and 3D.
△ Less
Submitted 6 February, 2023; v1 submitted 9 August, 2022;
originally announced August 2022.
-
Accelerating High-Order Mesh Optimization Using Finite Element Partial Assembly on GPUs
Authors:
Jean-Sylvain Camier,
Veselin Dobrev,
Patrick Knupp,
Tzanio Kolev,
Ketan Mittal,
Robert Rieben,
Vladimir Tomov
Abstract:
In this paper we present a new GPU-oriented mesh optimization method based on high-order finite elements. Our approach relies on node movement with fixed topology, through the Target-Matrix Optimization Paradigm (TMOP) and uses a global nonlinear solve over the whole computational mesh, i.e., all mesh nodes are moved together. A key property of the method is that the mesh optimization process is r…
▽ More
In this paper we present a new GPU-oriented mesh optimization method based on high-order finite elements. Our approach relies on node movement with fixed topology, through the Target-Matrix Optimization Paradigm (TMOP) and uses a global nonlinear solve over the whole computational mesh, i.e., all mesh nodes are moved together. A key property of the method is that the mesh optimization process is recast in terms of finite element operations, which allows us to utilize recent advances in the field of GPU-accelerated high-order finite element algorithms. For example, we reduce data motion by using tensor factorization and matrix-free methods, which have superior performance characteristics compared to traditional full finite element matrix assembly and offer advantages for GPU-based HPC hardware. We describe the major mathematical components of the method along with their efficient GPU-oriented implementation. In addition, we propose an easily reproducible mesh optimization test that can serve as a performance benchmark for the mesh optimization community.
△ Less
Submitted 1 December, 2022; v1 submitted 23 May, 2022;
originally announced May 2022.
-
Matrix-free approaches for GPU acceleration of a high-order finite element hydrodynamics application using MFEM, Umpire, and RAJA
Authors:
Arturo Vargas,
Thomas M. Stitt,
Kenneth Weiss,
Vladimir Z. Tomov,
Jean-Sylvain Camier,
Tzanio Kolev,
Robert N. Rieben
Abstract:
With the introduction of advanced heterogeneous computing architectures based on GPU accelerators, large-scale production codes have had to rethink their numerical algorithms and incorporate new programming models and memory management strategies in order to run efficiently on the latest supercomputers. In this work we discuss our co-design strategy to address these challenges and achieve performa…
▽ More
With the introduction of advanced heterogeneous computing architectures based on GPU accelerators, large-scale production codes have had to rethink their numerical algorithms and incorporate new programming models and memory management strategies in order to run efficiently on the latest supercomputers. In this work we discuss our co-design strategy to address these challenges and achieve performance and portability with MARBL, a next-generation multi-physics code in development at Lawrence Livermore National Laboratory. We present a two-fold approach, wherein new hardware is used to motivate both new algorithms and new abstraction layers, resulting in a single source application code suitable for a variety of platforms. Focusing on MARBL's ALE hydrodynamics package, we demonstrate scalability on different platforms and highlight that many of our innovations have been contributed back to open-source software libraries, such as MFEM (finite element algorithms) and RAJA (kernel abstractions).
△ Less
Submitted 13 December, 2021;
originally announced December 2021.
-
GPU Algorithms for Efficient Exascale Discretizations
Authors:
Ahmad Abdelfattah,
Valeria Barra,
Natalie Beams,
Ryan Bleile,
Jed Brown,
Jean-Sylvain Camier,
Robert Carson,
Noel Chalmers,
Veselin Dobrev,
Yohann Dudouit,
Paul Fischer,
Ali Karakus,
Stefan Kerkemeier,
Tzanio Kolev,
Yu-Hsiang Lan,
Elia Merzari,
Misun Min,
Malachi Phillips,
Thilina Rathnayake,
Robert Rieben,
Thomas Stitt,
Ananias Tomboulides,
Stanimire Tomov,
Vladimir Tomov,
Arturo Vargas
, et al. (2 additional authors not shown)
Abstract:
In this paper we describe the research and development activities in the Center for Efficient Exascale Discretization within the US Exascale Computing Project, targeting state-of-the-art high-order finite-element algorithms for high-order applications on GPU-accelerated platforms. We discuss the GPU developments in several components of the CEED software stack, including the libCEED, MAGMA, MFEM,…
▽ More
In this paper we describe the research and development activities in the Center for Efficient Exascale Discretization within the US Exascale Computing Project, targeting state-of-the-art high-order finite-element algorithms for high-order applications on GPU-accelerated platforms. We discuss the GPU developments in several components of the CEED software stack, including the libCEED, MAGMA, MFEM, libParanumal, and Nek projects. We report performance and capability improvements in several CEED-enabled applications on both NVIDIA and AMD GPU systems.
△ Less
Submitted 10 September, 2021;
originally announced September 2021.
-
Efficient Exascale Discretizations: High-Order Finite Element Methods
Authors:
Tzanio Kolev,
Paul Fischer,
Misun Min,
Jack Dongarra,
Jed Brown,
Veselin Dobrev,
Tim Warburton,
Stanimire Tomov,
Mark S. Shephard,
Ahmad Abdelfattah,
Valeria Barra,
Natalie Beams,
Jean-Sylvain Camier,
Noel Chalmers,
Yohann Dudouit,
Ali Karakus,
Ian Karlin,
Stefan Kerkemeier,
Yu-Hsiang Lan,
David Medina,
Elia Merzari,
Aleksandr Obabko,
Will Pazner,
Thilina Rathnayake,
Cameron W. Smith
, et al. (5 additional authors not shown)
Abstract:
Efficient exploitation of exascale architectures requires rethinking of the numerical algorithms used in many large-scale applications. These architectures favor algorithms that expose ultra fine-grain parallelism and maximize the ratio of floating point operations to energy intensive data movement. One of the few viable approaches to achieve high efficiency in the area of PDE discretizations on u…
▽ More
Efficient exploitation of exascale architectures requires rethinking of the numerical algorithms used in many large-scale applications. These architectures favor algorithms that expose ultra fine-grain parallelism and maximize the ratio of floating point operations to energy intensive data movement. One of the few viable approaches to achieve high efficiency in the area of PDE discretizations on unstructured grids is to use matrix-free/partially-assembled high-order finite element methods, since these methods can increase the accuracy and/or lower the computational time due to reduced data motion. In this paper we provide an overview of the research and development activities in the Center for Efficient Exascale Discretizations (CEED), a co-design center in the Exascale Computing Project that is focused on the development of next-generation discretization software and algorithms to enable a wide range of finite element applications to run efficiently on future hardware. CEED is a research partnership involving more than 30 computational scientists from two US national labs and five universities, including members of the Nek5000, MFEM, MAGMA and PETSc projects. We discuss the CEED co-design activities based on targeted benchmarks, miniapps and discretization libraries and our work on performance optimizations for large-scale GPU architectures. We also provide a broad overview of research and development activities in areas such as unstructured adaptive mesh refinement algorithms, matrix-free linear solvers, high-order data visualization, and list examples of collaborations with several ECP and external applications.
△ Less
Submitted 10 September, 2021;
originally announced September 2021.
-
Adaptive Surface Fitting and Tangential Relaxation for High-Order Mesh Optimization
Authors:
Patrick Knupp,
Tzanio Kolev,
Ketan Mittal,
Vladimir Z. Tomov
Abstract:
We propose a new approach for controlling the characteristics of certain mesh faces during optimization of high-order curved meshes. The practical goals are tangential relaxation along initially aligned curved boundaries and internal surfaces, and mesh fitting to initially non-aligned surfaces. The distinct feature of the method is that it utilizes discrete finite element functions (for example le…
▽ More
We propose a new approach for controlling the characteristics of certain mesh faces during optimization of high-order curved meshes. The practical goals are tangential relaxation along initially aligned curved boundaries and internal surfaces, and mesh fitting to initially non-aligned surfaces. The distinct feature of the method is that it utilizes discrete finite element functions (for example level set functions) to define implicit surfaces, which are used to adapt the positions of certain mesh nodes. The algorithm does not require CAD descriptions or analytic parametrizations, and can be beneficial in computations with dynamically changing geometry, for example shape optimization and moving mesh multimaterial simulations. The main advantage of this approach is that it completely avoids geometric operations (e.g., surface projections), and all calculations can be performed through finite element operations.
△ Less
Submitted 25 May, 2021;
originally announced May 2021.
-
Reinforcement Learning for Adaptive Mesh Refinement
Authors:
Jiachen Yang,
Tarik Dzanic,
Brenden Petersen,
Jun Kudo,
Ketan Mittal,
Vladimir Tomov,
Jean-Sylvain Camier,
Tuo Zhao,
Hongyuan Zha,
Tzanio Kolev,
Robert Anderson,
Daniel Faissol
Abstract:
Large-scale finite element simulations of complex physical systems governed by partial differential equations (PDE) crucially depend on adaptive mesh refinement (AMR) to allocate computational budget to regions where higher resolution is required. Existing scalable AMR methods make heuristic refinement decisions based on instantaneous error estimation and thus do not aim for long-term optimality o…
▽ More
Large-scale finite element simulations of complex physical systems governed by partial differential equations (PDE) crucially depend on adaptive mesh refinement (AMR) to allocate computational budget to regions where higher resolution is required. Existing scalable AMR methods make heuristic refinement decisions based on instantaneous error estimation and thus do not aim for long-term optimality over an entire simulation. We propose a novel formulation of AMR as a Markov decision process and apply deep reinforcement learning (RL) to train refinement policies directly from simulation. AMR poses a new problem for RL as both the state dimension and available action set changes at every step, which we solve by proposing new policy architectures with differing generality and inductive bias. The model sizes of these policy architectures are independent of the mesh size and hence can be deployed on larger simulations than those used at train time. We demonstrate in comprehensive experiments on static function estimation and time-dependent equations that RL policies can be trained on problems without using ground truth solutions, are competitive with a widely-used error estimator, and generalize to larger, more complex, and unseen test problems.
△ Less
Submitted 21 February, 2023; v1 submitted 1 March, 2021;
originally announced March 2021.
-
hr-adaptivity for nonconforming high-order meshes with the target matrix optimization paradigm
Authors:
Veselin Dobrev,
Patrick Knupp,
Tzanio Kolev,
Ketan Mittal,
Vladimir Tomov
Abstract:
We present an $hr$-adaptivity framework for optimization of high-order meshes. This work extends the $r$-adaptivity method for mesh optimization by Dobrev et al., where we utilized the Target-Matrix Optimization Paradigm (TMOP) to minimize a functional that depends on each element's current and target geometric parameters: element aspect-ratio, size, skew, and orientation. Since fixed mesh topolog…
▽ More
We present an $hr$-adaptivity framework for optimization of high-order meshes. This work extends the $r$-adaptivity method for mesh optimization by Dobrev et al., where we utilized the Target-Matrix Optimization Paradigm (TMOP) to minimize a functional that depends on each element's current and target geometric parameters: element aspect-ratio, size, skew, and orientation. Since fixed mesh topology limits the ability to achieve the target size and aspect-ratio at each position, in this paper we augment the $r$-adaptivity framework with nonconforming adaptive mesh refinement to further reduce the error with respect to the target geometric parameters. The proposed formulation, referred to as $hr$-adaptivity, introduces TMOP-based quality estimators to satisfy the aspect-ratio-target via anisotropic refinements and size-target via isotropic refinements in each element of the mesh. The methodology presented is purely algebraic, extends to both simplices and hexahedra/quadrilaterals of any order, and supports nonconforming isotropic and anisotropic refinements in 2D and 3D. Using a problem with a known exact solution, we demonstrate the effectiveness of $hr$-adaptivity over both $r-$ and $h$-adaptivity in obtaining similar accuracy in the solution with significantly fewer degrees of freedom. We also present several examples that show that $hr$-adaptivity can help satisfy geometric targets even when $r$-adaptivity fails to do so, due to the topology of the initial mesh.
△ Less
Submitted 5 October, 2020;
originally announced October 2020.
-
A global view on the colliding-wind binary WR 147
Authors:
Svetozar A. Zhekov,
Blagovest V. Petrov,
Toma V. Tomov,
Peter Pessev
Abstract:
We present results from a global view on the colliding-wind binary WR 147. We analysed new optical spectra of WR 147 obtained with Gran Telescopio CANARIAS and archive spectra from the Hubble Space Telescope by making use of modern atmosphere models accounting for optically thin clumping. We adopted a grid-modelling approach to derive some basic physical characteristics of both stellar components…
▽ More
We present results from a global view on the colliding-wind binary WR 147. We analysed new optical spectra of WR 147 obtained with Gran Telescopio CANARIAS and archive spectra from the Hubble Space Telescope by making use of modern atmosphere models accounting for optically thin clumping. We adopted a grid-modelling approach to derive some basic physical characteristics of both stellar components in WR 147. For the currently accepted distance of 630 pc to WR 147, the values of mass-loss rate derived from modelling its optical spectra are in acceptable correspondence with that from modelling its X-ray emission. However, they give a lower radio flux than observed. A plausible solution for this problem could be if the volume filling factor at large distances from the star (radio-formation region) is smaller than close to the star (optical-formation region). Adopting this, the model can match well both optical and thermal radio emission from WR 147. The global view on the colliding-wind binary WR 147 thus shows that its observational properties in different spectral domains can be explained in a self-consistent physical picture.
△ Less
Submitted 7 April, 2020;
originally announced April 2020.
-
Simulation-Driven Optimization of High-Order Meshes in ALE Hydrodynamics
Authors:
Veselin Dobrev,
Patrick Knupp,
Tzanio Kolev,
Ketan Mittal,
Robert Rieben,
Vladimir Tomov
Abstract:
In this paper we propose tools for high-order mesh optimization and demonstrate their benefits in the context of multi-material Arbitrary Lagrangian-Eulerian (ALE) compressible shock hydrodynamic applications. The mesh optimization process is driven by information provided by the simulation which uses the optimized mesh, such as shock positions, material regions, known error estimates, etc. These…
▽ More
In this paper we propose tools for high-order mesh optimization and demonstrate their benefits in the context of multi-material Arbitrary Lagrangian-Eulerian (ALE) compressible shock hydrodynamic applications. The mesh optimization process is driven by information provided by the simulation which uses the optimized mesh, such as shock positions, material regions, known error estimates, etc. These simulation features are usually represented discretely, for instance, as finite element functions on the Lagrangian mesh. The discrete nature of the input is critical for the practical applicability of the algorithms we propose and distinguishes this work from approaches that strictly require analytical information. Our methods are based on node movement through a high-order extension of the Target-Matrix Optimization Paradigm (TMOP) of Knupp. The proposed formulation is fully algebraic and relies only on local Jacobian matrices, so it is applicable to all types of mesh elements, in 2D and 3D, and any order of the mesh. We discuss the notions of constructing adaptive target matrices and obtaining their derivatives, reconstructing discrete data in intermediate meshes, node limiting that enables improvement of global mesh quality while preserving space-dependent local mesh features, and appropriate normalization of the objective function. The adaptivity methods are combined with automatic ALE triggers that can provide robustness of the mesh evolution and avoid excessive remap procedures. The benefits of the new high-order TMOP technology are illustrated on several simulations performed in the high-order ALE application BLAST.
△ Less
Submitted 30 January, 2020;
originally announced January 2020.
-
MFEM: a modular finite element methods library
Authors:
Robert Anderson,
Julian Andrej,
Andrew Barker,
Jamie Bramwell,
Jean-Sylvain Camier,
Jakub Cerveny,
Veselin Dobrev,
Yohann Dudouit,
Aaron Fisher,
Tzanio Kolev,
Will Pazner,
Mark Stowell,
Vladimir Tomov,
Johann Dahm,
David Medina,
Stefano Zampini
Abstract:
MFEM is an open-source, lightweight, flexible and scalable C++ library for modular finite element methods that features arbitrary high-order finite element meshes and spaces, support for a wide variety of discretization approaches and emphasis on usability, portability, and high-performance computing efficiency. MFEM's goal is to provide application scientists with access to cutting-edge algorithm…
▽ More
MFEM is an open-source, lightweight, flexible and scalable C++ library for modular finite element methods that features arbitrary high-order finite element meshes and spaces, support for a wide variety of discretization approaches and emphasis on usability, portability, and high-performance computing efficiency. MFEM's goal is to provide application scientists with access to cutting-edge algorithms for high-order finite element meshing, discretizations and linear solvers, while enabling researchers to quickly and easily develop and test new algorithms in very general, fully unstructured, high-order, parallel and GPU-accelerated settings. In this paper we describe the underlying algorithms and finite element abstractions provided by MFEM, discuss the software implementation, and illustrate various applications of the library.
△ Less
Submitted 13 July, 2020; v1 submitted 20 November, 2019;
originally announced November 2019.
-
A Quadratic Programming Flux Correction Method for High-Order DG Discretizations of SN Transport
Authors:
Ben C. Yee,
Samuel S. Olivier,
Terry S. Haut,
Milan Holec,
Vladimir Z. Tomov,
Peter G. Maginot
Abstract:
We present a new flux-fixup approach for arbitrarily high-order discontinuous Galerkin discretizations of the SN transport equation. This approach is sweep-compatible: as the transport sweep is performed, a local quadratic programming (QP) problem is solved in each spatial cell to ensure that the solution satisfies certain physical constraints, including local particle balance. The constraints can…
▽ More
We present a new flux-fixup approach for arbitrarily high-order discontinuous Galerkin discretizations of the SN transport equation. This approach is sweep-compatible: as the transport sweep is performed, a local quadratic programming (QP) problem is solved in each spatial cell to ensure that the solution satisfies certain physical constraints, including local particle balance. The constraints can be chosen in two ways, leading to two variants of the method: QP Zero (QPZ) and QP Maximum Principle (QPMP). The coefficients of the solution are constrained to be nonnegative in QPZ, and they are constrained by an approximate discrete maximum principle in QPMP. There are two primary takeaways in this paper. First, it is shown that the QPMP method, when used with the positive Bernstein basis, eliminates negativities, preserves high-order accuracy for smooth problems, and significantly dampens unphysical oscillations in the solution. The second takeaway is that the Variable Eddington Factor (VEF) method can be used to accelerate the convergence of source iteration with fixup for problems with optically thick regions. Regardless of whether a fixup is applied, source iteration converges slowly when optically thick regions are present and acceleration is needed. When VEF is combined with fixed-up transport sweeps, the result is a scheme that produces a nonnegative solution, converges independently of the mean free path, and, in the case of the QPMP fixup, adheres to an approximate discrete maximum principle.
△ Less
Submitted 26 June, 2020; v1 submitted 7 October, 2019;
originally announced October 2019.
-
XMM-Newton observations of the symbiotic recurrent nova T CrB: evolution of X-ray emission during the active phase
Authors:
Svetozar A. Zhekov,
Toma V. Tomov
Abstract:
We present an analysis of the XMM-Newton observations of the symbiotic recurrent nova T CrB, obtained during its active phase that started in 2015. The XMM-Newton spectra of T CrB have two prominent components: a soft one (0.2 - 0.6 keV), well represented by black-body emission, and a heavily absorbed hard component (2 - 10 keV), well matched by optically-thin plasma emission with high temperature…
▽ More
We present an analysis of the XMM-Newton observations of the symbiotic recurrent nova T CrB, obtained during its active phase that started in 2015. The XMM-Newton spectra of T CrB have two prominent components: a soft one (0.2 - 0.6 keV), well represented by black-body emission, and a heavily absorbed hard component (2 - 10 keV), well matched by optically-thin plasma emission with high temperature (kT ~ 8 keV). The XMM-Newton observations reveal evolution of the X-ray emission from T CrB in its active phase. Namely, the soft component in its spectrum is decreasing with time while the opposite is true for the hard component. Comparison with data obtained in the quiescent phase shows that the soft component is typical only for the active phase, while the hard component is present in both phases but it is considerably stronger in the quiescent phase. Presence of stochastic variability (flickering) on time-scales of minutes and hours is confirmed both in X-rays and UV (UVM2 filter of the XMM-Newton optical monitor). On the other hand, periodic variability of 6000-6500 s is found for the first time in the soft X-ray emission (0.2 - 0.6 keV) from T CrB. We associate this periodic variability with the rotational period of the white dwarf in this symbiotic binary.
△ Less
Submitted 21 August, 2019;
originally announced August 2019.
-
DSA Preconditioning for DG discretizations of $S_{N}$ transport and High-Order curved meshes
Authors:
T. S. Haut,
B. S. Southworth,
P. G. Maginot,
V. Z. Tomov
Abstract:
This paper derives and analyzes new diffusion synthetic acceleration (DSA) preconditioners for the SN transport equation when discretized with a high-order (HO) discontinuous Galerkin (DG) discretization. DSA preconditioners address the need to accelerate solving SN transport when the mean free path $\varepsilon$ of particles is small and the condition number of the SN transport equation scales li…
▽ More
This paper derives and analyzes new diffusion synthetic acceleration (DSA) preconditioners for the SN transport equation when discretized with a high-order (HO) discontinuous Galerkin (DG) discretization. DSA preconditioners address the need to accelerate solving SN transport when the mean free path $\varepsilon$ of particles is small and the condition number of the SN transport equation scales like $O(\varepsilon^{-2})$. By expanding the SN transport operator in $\varepsilon$ and employing a singular matrix perturbation analysis, we derive a DSA matrix that reduces to the symmetric interior penalty (SIP) DG discretization of diffusion when the mesh is first-order and the total opacity is constant. We prove that preconditioning HO DG SN transport with the SIP DSA matrix results in an $O(\varepsilon)$ perturbation of the identity, and fixed-point iteration therefore converges rapidly for optically thick problems. However, the SIP DSA matrix is conditioned like $O(\varepsilon^{-1})$, making it difficult to invert for small $\varepsilon$. We further derive a new two-part, additive DSA preconditioner based on a continuous discretization of diffusion-reaction, which has a condition number independent of $\varepsilon$, and prove that this DSA variant has the same theoretical efficiency as the SIP DSA preconditioner in the optically thick limit. The analysis is extended to the case of HO (curved) meshes, where so-called mesh cycles can result from elements both being upwind of each other. In particular, we prove that performing two additional transport sweeps between DSA steps yields the same theoretical conditioning of fixed-point iterations as in the cycle-free case. Theoretical results are validated by numerical experiments on HO, highly curved meshes generated from an ALE hydrodynamics code, where the additional inner sweeps between DSA steps offer up to a 4x reduction in total sweeps.
△ Less
Submitted 20 July, 2020; v1 submitted 25 October, 2018;
originally announced October 2018.
-
An Efficient Sweep-based Solver for the $S_{N}$ Equations on High-Order Meshes
Authors:
T. S. Haut,
P. G. Maginot,
V. Z. Tomov,
B. S. Southworth,
T. A. Brunner,
T. S. Bailey
Abstract:
We propose a graph-based sweep algorithm for solving the steady state, mono-energetic discrete ordinates on meshes of high-order curved mesh elements. Our spatial discretization consists of arbitrarily high-order discontinuous Galerkin finite elements using upwinding at mesh element faces. To determine mesh element sweep ordering, we define a directed, weighted graph whose vertices correspond to m…
▽ More
We propose a graph-based sweep algorithm for solving the steady state, mono-energetic discrete ordinates on meshes of high-order curved mesh elements. Our spatial discretization consists of arbitrarily high-order discontinuous Galerkin finite elements using upwinding at mesh element faces. To determine mesh element sweep ordering, we define a directed, weighted graph whose vertices correspond to mesh elements, and whose edges correspond to mesh element upwind dependencies. This graph is made acyclic by removing select edges in a way that approximately minimizes the sum of removed edge weights. Once the set of removed edges is determined, transport sweeps are performed by lagging the upwind dependency associated with the removed edges. The proposed algorithm is tested on several 2D and 3D meshes composed of high-order curved mesh elements.
△ Less
Submitted 9 January, 2019; v1 submitted 25 October, 2018;
originally announced October 2018.
-
An XMM-Newton observation of the symbiotic star AG Peg: the X-ray emission after the end of its 2015 outburst
Authors:
Svetozar A. Zhekov,
Toma V. Tomov
Abstract:
We present an analysis of the XMM-Newton observation of the symbiotic star AG Peg, obtained after the end of its 2015 outburst. The X-ray emission of AG Peg is soft and of thermal origin. AG Peg is an X-ray source of class beta of the X-ray sources amongst the symbiotic stars, whose X-ray spectrum is well matched by a two-temperature optically-thin plasma emission (kT_1 ~ 0.14 keV and kT_2 ~ 0.66…
▽ More
We present an analysis of the XMM-Newton observation of the symbiotic star AG Peg, obtained after the end of its 2015 outburst. The X-ray emission of AG Peg is soft and of thermal origin. AG Peg is an X-ray source of class beta of the X-ray sources amongst the symbiotic stars, whose X-ray spectrum is well matched by a two-temperature optically-thin plasma emission (kT_1 ~ 0.14 keV and kT_2 ~ 0.66 keV). The X-ray emission of the class beta sources is believed to originate from colliding stellar winds (CSW) in binary system. If we adopt the CSW picture, the theoretical CSW spectra match well the observed properties of the XMM-Newton spectra of AG Peg. However, we need a solid evidence that a massive-enough hot-star wind is present in the post-outburst state of AG Peg to proof the validity of the CSW picture for this symbiotic binary. No short-term X-ray variability is detected while the UV emission of AG Peg shows stochastic variability (flickering) on time-scales of minutes and hours.
△ Less
Submitted 24 September, 2018;
originally announced September 2018.
-
The Target-Matrix Optimization Paradigm for High-Order Meshes
Authors:
Veselin Dobrev,
Patrick Knupp,
Tzanio Kolev,
Ketan Mittal,
Vladimir Tomov
Abstract:
We describe a framework for controlling and improving the quality of high-order finite element meshes based on extensions of the Target-Matrix Optimization Paradigm (TMOP) of Knupp. This approach allows high-order applications to have a very precise control over local mesh quality, while still improving the mesh globally. We address the adaption of various TMOP components to the settings of genera…
▽ More
We describe a framework for controlling and improving the quality of high-order finite element meshes based on extensions of the Target-Matrix Optimization Paradigm (TMOP) of Knupp. This approach allows high-order applications to have a very precise control over local mesh quality, while still improving the mesh globally. We address the adaption of various TMOP components to the settings of general isoparametric element mappings, including the mesh quality metric in 2D and 3D, the selection of sample points and the solution of the resulting mesh optimization problem. We also investigate additional practical concerns, such as tangential relaxation and restricting the deviation from the original mesh. The benefits of the new high-order TMOP algorithms are illustrated on a number of test problems and examples from a high-order arbitrary Eulerian-Lagrangian (ALE) application. Our implementation is freely available in an open-source library form.
△ Less
Submitted 25 July, 2018;
originally announced July 2018.
-
Algebraic Hybridization and Static Condensation with Application to Scalable H(div) Preconditioning
Authors:
Veselin A. Dobrev,
Tzanio V. Kolev,
Chak S. Lee,
Vladimir Z. Tomov,
Panayot S. Vassilevski
Abstract:
We propose an unified algebraic approach for static condensation and hybridization, two popular techniques in finite element discretizations. The algebraic approach is supported by the construction of scalable solvers for problems involving H(div)-spaces discretized by conforming (Raviart-Thomas) elements of arbitrary order. We illustrate through numerical experiments the relative performance of t…
▽ More
We propose an unified algebraic approach for static condensation and hybridization, two popular techniques in finite element discretizations. The algebraic approach is supported by the construction of scalable solvers for problems involving H(div)-spaces discretized by conforming (Raviart-Thomas) elements of arbitrary order. We illustrate through numerical experiments the relative performance of the two (in some sense dual) techniques in comparison with a state-of-the-art parallel solver, ADS, available in the software hypre and MFEM. The superior performance of the hybridization technique is clearly demonstrated with increased benefit for higher order elements.
△ Less
Submitted 26 January, 2018;
originally announced January 2018.
-
AG Pegasi - now a classical symbiotic star in outburst?
Authors:
T. V. Tomov,
K. A. Stoyanov,
R. K. Zamanov
Abstract:
Optical spectroscopy study of the recent AG Peg outburst observed during the second half of 2015 is presented. Considerable variations of the intensity and the shape of the spectral features as well as the changes of the hot component parameters, caused by the outburst, are discussed and certain similarities between the outburst of AG Peg and the outburst of a classical symbiotic stars are shown.…
▽ More
Optical spectroscopy study of the recent AG Peg outburst observed during the second half of 2015 is presented. Considerable variations of the intensity and the shape of the spectral features as well as the changes of the hot component parameters, caused by the outburst, are discussed and certain similarities between the outburst of AG Peg and the outburst of a classical symbiotic stars are shown. It seems that after the end of the symbiotic nova phase, AG Peg became a member of the classical symbiotic stars group.
△ Less
Submitted 9 August, 2016;
originally announced August 2016.
-
Fast Rotation of the N=Z Nucleus 36Ar
Authors:
C. E. Svensson,
A. O. Macchiavelli,
A. Juodagalvis,
A. Poves,
I. Ragnarsson,
S. Aberg,
D. E. Appelbe,
R. A. E. Austin,
C. Baktash,
G. C. Ball,
M. P. Carpenter,
E. Caurier,
R. M. Clark,
M. Cromaz,
M. A. Deleplanque,
R. M. Diamond,
P. Fallon,
M. Furlotti,
A. Galindo-Uribarri,
R. V. F. Janssens,
G. J. Lane,
I. Y. Lee,
M. Lipoglavsek,
F. Nowacki,
S. D. Paul
, et al. (8 additional authors not shown)
Abstract:
A highly-deformed rotational band has been identified in the N=Z nucleus 36Ar. At high spin the band is observed to its presumed termination at I=16+, while at low spin it has been firmly linked to previously known states in 36Ar. Spins, parities, and absolute excitation energies have thus been determined throughout the band. Lifetime measurements establish a large low-spin quadrupole deformatio…
▽ More
A highly-deformed rotational band has been identified in the N=Z nucleus 36Ar. At high spin the band is observed to its presumed termination at I=16+, while at low spin it has been firmly linked to previously known states in 36Ar. Spins, parities, and absolute excitation energies have thus been determined throughout the band. Lifetime measurements establish a large low-spin quadrupole deformation (beta_2=0.46+-0.03) and indicate a decreasing collectivity as the band termination is approached. With effectively complete spectroscopic information and a valence space large enough for significant collectivity to develop, yet small enough to be meaningfully approached from the shell model perspective, this rotational band in 36Ar provides many exciting opportunities to test and compare complementary models of collective motion in nuclei.
△ Less
Submitted 3 April, 2001;
originally announced April 2001.