WorldWideScience

Sample records for elliptic equation solver

  1. Implementing parallel elliptic solver on a Beowulf cluster

    Directory of Open Access Journals (Sweden)

    Marcin Paprzycki

    1999-12-01

    Full Text Available In a recent paper cite{zara} a parallel direct solver for the linear systems arising from elliptic partial differential equations has been proposed. The aim of this note is to present the initial evaluation of the performance characteristics of this algorithm on Beowulf-type cluster. In this context the performance of PVM and MPI based implementations is compared.

  2. The Closest Point Method and Multigrid Solvers for Elliptic Equations on Surfaces

    KAUST Repository

    Chen, Yujia; Macdonald, Colin B.

    2015-01-01

    © 2015 Society for Industrial and Applied Mathematics. Elliptic partial differential equations are important from both application and analysis points of view. In this paper we apply the closest point method to solve elliptic equations on general

  3. The Closest Point Method and Multigrid Solvers for Elliptic Equations on Surfaces

    KAUST Repository

    Chen, Yujia

    2015-01-01

    © 2015 Society for Industrial and Applied Mathematics. Elliptic partial differential equations are important from both application and analysis points of view. In this paper we apply the closest point method to solve elliptic equations on general curved surfaces. Based on the closest point representation of the underlying surface, we formulate an embedding equation for the surface elliptic problem, then discretize it using standard finite differences and interpolation schemes on banded but uniform Cartesian grids. We prove the convergence of the difference scheme for the Poisson\\'s equation on a smooth closed curve. In order to solve the resulting large sparse linear systems, we propose a specific geometric multigrid method in the setting of the closest point method. Convergence studies in both the accuracy of the difference scheme and the speed of the multigrid algorithm show that our approaches are effective.

  4. Robust and scalable hierarchical matrix-based fast direct solver and preconditioner for the numerical solution of elliptic partial differential equations

    KAUST Repository

    Chavez, Gustavo Ivan

    2017-07-10

    This dissertation introduces a novel fast direct solver and preconditioner for the solution of block tridiagonal linear systems that arise from the discretization of elliptic partial differential equations on a Cartesian product mesh, such as the variable-coefficient Poisson equation, the convection-diffusion equation, and the wave Helmholtz equation in heterogeneous media. The algorithm extends the traditional cyclic reduction method with hierarchical matrix techniques. The resulting method exposes substantial concurrency, and its arithmetic operations and memory consumption grow only log-linearly with problem size, assuming bounded rank of off-diagonal matrix blocks, even for problems with arbitrary coefficient structure. The method can be used as a standalone direct solver with tunable accuracy, or as a black-box preconditioner in conjunction with Krylov methods. The challenges that distinguish this work from other thrusts in this active field are the hybrid distributed-shared parallelism that can demonstrate the algorithm at large-scale, full three-dimensionality, and the three stressors of the current state-of-the-art multigrid technology: high wavenumber Helmholtz (indefiniteness), high Reynolds convection (nonsymmetry), and high contrast diffusion (inhomogeneity). Numerical experiments corroborate the robustness, accuracy, and complexity claims and provide a baseline of the performance and memory footprint by comparisons with competing approaches such as the multigrid solver hypre, and the STRUMPACK implementation of the multifrontal factorization with hierarchically semi-separable matrices. The companion implementation can utilize many thousands of cores of Shaheen, KAUST\\'s Haswell-based Cray XC-40 supercomputer, and compares favorably with other implementations of hierarchical solvers in terms of time-to-solution and memory consumption.

  5. Parallelization of elliptic solver for solving 1D Boussinesq model

    Science.gov (United States)

    Tarwidi, D.; Adytia, D.

    2018-03-01

    In this paper, a parallel implementation of an elliptic solver in solving 1D Boussinesq model is presented. Numerical solution of Boussinesq model is obtained by implementing a staggered grid scheme to continuity, momentum, and elliptic equation of Boussinesq model. Tridiagonal system emerging from numerical scheme of elliptic equation is solved by cyclic reduction algorithm. The parallel implementation of cyclic reduction is executed on multicore processors with shared memory architectures using OpenMP. To measure the performance of parallel program, large number of grids is varied from 28 to 214. Two test cases of numerical experiment, i.e. propagation of solitary and standing wave, are proposed to evaluate the parallel program. The numerical results are verified with analytical solution of solitary and standing wave. The best speedup of solitary and standing wave test cases is about 2.07 with 214 of grids and 1.86 with 213 of grids, respectively, which are executed by using 8 threads. Moreover, the best efficiency of parallel program is 76.2% and 73.5% for solitary and standing wave test cases, respectively.

  6. Domain Decomposition Solvers for Frequency-Domain Finite Element Equations

    KAUST Repository

    Copeland, Dylan

    2010-10-05

    The paper is devoted to fast iterative solvers for frequency-domain finite element equations approximating linear and nonlinear parabolic initial boundary value problems with time-harmonic excitations. Switching from the time domain to the frequency domain allows us to replace the expensive time-integration procedure by the solution of a simple linear elliptic system for the amplitudes belonging to the sine- and to the cosine-excitation or a large nonlinear elliptic system for the Fourier coefficients in the linear and nonlinear case, respectively. The fast solution of the corresponding linear and nonlinear system of finite element equations is crucial for the competitiveness of this method. © 2011 Springer-Verlag Berlin Heidelberg.

  7. Domain Decomposition Solvers for Frequency-Domain Finite Element Equations

    KAUST Repository

    Copeland, Dylan; Kolmbauer, Michael; Langer, Ulrich

    2010-01-01

    The paper is devoted to fast iterative solvers for frequency-domain finite element equations approximating linear and nonlinear parabolic initial boundary value problems with time-harmonic excitations. Switching from the time domain to the frequency domain allows us to replace the expensive time-integration procedure by the solution of a simple linear elliptic system for the amplitudes belonging to the sine- and to the cosine-excitation or a large nonlinear elliptic system for the Fourier coefficients in the linear and nonlinear case, respectively. The fast solution of the corresponding linear and nonlinear system of finite element equations is crucial for the competitiveness of this method. © 2011 Springer-Verlag Berlin Heidelberg.

  8. AQUASOL: An efficient solver for the dipolar Poisson-Boltzmann-Langevin equation.

    Science.gov (United States)

    Koehl, Patrice; Delarue, Marc

    2010-02-14

    The Poisson-Boltzmann (PB) formalism is among the most popular approaches to modeling the solvation of molecules. It assumes a continuum model for water, leading to a dielectric permittivity that only depends on position in space. In contrast, the dipolar Poisson-Boltzmann-Langevin (DPBL) formalism represents the solvent as a collection of orientable dipoles with nonuniform concentration; this leads to a nonlinear permittivity function that depends both on the position and on the local electric field at that position. The differences in the assumptions underlying these two models lead to significant differences in the equations they generate. The PB equation is a second order, elliptic, nonlinear partial differential equation (PDE). Its response coefficients correspond to the dielectric permittivity and are therefore constant within each subdomain of the system considered (i.e., inside and outside of the molecules considered). While the DPBL equation is also a second order, elliptic, nonlinear PDE, its response coefficients are nonlinear functions of the electrostatic potential. Many solvers have been developed for the PB equation; to our knowledge, none of these can be directly applied to the DPBL equation. The methods they use may adapt to the difference; their implementations however are PBE specific. We adapted the PBE solver originally developed by Holst and Saied [J. Comput. Chem. 16, 337 (1995)] to the problem of solving the DPBL equation. This solver uses a truncated Newton method with a multigrid preconditioner. Numerical evidences suggest that it converges for the DPBL equation and that the convergence is superlinear. It is found however to be slow and greedy in memory requirement for problems commonly encountered in computational biology and computational chemistry. To circumvent these problems, we propose two variants, a quasi-Newton solver based on a simplified, inexact Jacobian and an iterative self-consistent solver that is based directly on the PBE

  9. Differential equations problem solver

    CERN Document Server

    Arterburn, David R

    2012-01-01

    REA's Problem Solvers is a series of useful, practical, and informative study guides. Each title in the series is complete step-by-step solution guide. The Differential Equations Problem Solver enables students to solve difficult problems by showing them step-by-step solutions to Differential Equations problems. The Problem Solvers cover material ranging from the elementary to the advanced and make excellent review books and textbook companions. They're perfect for undergraduate and graduate studies.The Differential Equations Problem Solver is the perfect resource for any class, any exam, and

  10. Application of fast Fourier transforms to the direct solution of a class of two-dimensional separable elliptic equations on the sphere

    Science.gov (United States)

    Moorthi, Shrinivas; Higgins, R. W.

    1993-01-01

    An efficient, direct, second-order solver for the discrete solution of a class of two-dimensional separable elliptic equations on the sphere (which generally arise in implicit and semi-implicit atmospheric models) is presented. The method involves a Fourier transformation in longitude and a direct solution of the resulting coupled second-order finite-difference equations in latitude. The solver is made efficient by vectorizing over longitudinal wave-number and by using a vectorized fast Fourier transform routine. It is evaluated using a prescribed solution method and compared with a multigrid solver and the standard direct solver from FISHPAK.

  11. MGLab3D: An interactive environment for iterative solvers for elliptic PDEs in two and three dimensions

    Energy Technology Data Exchange (ETDEWEB)

    Bordner, J.; Saied, F. [Univ. of Illinois, Urbana, IL (United States)

    1996-12-31

    GLab3D is an enhancement of an interactive environment (MGLab) for experimenting with iterative solvers and multigrid algorithms. It is implemented in MATLAB. The new version has built-in 3D elliptic pde`s and several iterative methods and preconditioners that were not available in the original version. A sparse direct solver option has also been included. The multigrid solvers have also been extended to 3D. The discretization and pde domains are restricted to standard finite differences on the unit square/cube. The power of this software studies in the fact that no programming is needed to solve, for example, the convection-diffusion equation in 3D with TFQMR and a customized V-cycle preconditioner, for a variety of problem sizes and mesh Reynolds, numbers. In addition to the graphical user interface, some sample drivers are included to show how experiments can be composed using the underlying suite of problems and solvers.

  12. Fast Multipole-Based Elliptic PDE Solver and Preconditioner

    KAUST Repository

    Ibeid, Huda

    2016-12-07

    Exascale systems are predicted to have approximately one billion cores, assuming Gigahertz cores. Limitations on affordable network topologies for distributed memory systems of such massive scale bring new challenges to the currently dominant parallel programing model. Currently, there are many efforts to evaluate the hardware and software bottlenecks of exascale designs. It is therefore of interest to model application performance and to understand what changes need to be made to ensure extrapolated scalability. Fast multipole methods (FMM) were originally developed for accelerating N-body problems for particle-based methods in astrophysics and molecular dynamics. FMM is more than an N-body solver, however. Recent efforts to view the FMM as an elliptic PDE solver have opened the possibility to use it as a preconditioner for even a broader range of applications. In this thesis, we (i) discuss the challenges for FMM on current parallel computers and future exascale architectures, with a focus on inter-node communication, and develop a performance model that considers the communication patterns of the FMM for spatially quasi-uniform distributions, (ii) employ this performance model to guide performance and scaling improvement of FMM for all-atom molecular dynamics simulations of uniformly distributed particles, and (iii) demonstrate that, beyond its traditional use as a solver in problems for which explicit free-space kernel representations are available, the FMM has applicability as a preconditioner in finite domain elliptic boundary value problems, by equipping it with boundary integral capability for satisfying conditions at finite boundaries and by wrapping it in a Krylov method for extensibility to more general operators. Compared with multilevel methods, FMM is capable of comparable algebraic convergence rates down to the truncation error of the discretized PDE, and it has superior multicore and distributed memory scalability properties on commodity

  13. Domain decomposition solvers for nonlinear multiharmonic finite element equations

    KAUST Repository

    Copeland, D. M.

    2010-01-01

    In many practical applications, for instance, in computational electromagnetics, the excitation is time-harmonic. Switching from the time domain to the frequency domain allows us to replace the expensive time-integration procedure by the solution of a simple elliptic equation for the amplitude. This is true for linear problems, but not for nonlinear problems. However, due to the periodicity of the solution, we can expand the solution in a Fourier series. Truncating this Fourier series and approximating the Fourier coefficients by finite elements, we arrive at a large-scale coupled nonlinear system for determining the finite element approximation to the Fourier coefficients. The construction of fast solvers for such systems is very crucial for the efficiency of this multiharmonic approach. In this paper we look at nonlinear, time-harmonic potential problems as simple model problems. We construct and analyze almost optimal solvers for the Jacobi systems arising from the Newton linearization of the large-scale coupled nonlinear system that one has to solve instead of performing the expensive time-integration procedure. © 2010 de Gruyter.

  14. International Workshop on Elliptic and Parabolic Equations

    CERN Document Server

    Schrohe, Elmar; Seiler, Jörg; Walker, Christoph

    2015-01-01

    This volume covers the latest research on elliptic and parabolic equations and originates from the international Workshop on Elliptic and Parabolic Equations, held September 10-12, 2013 at the Leibniz Universität Hannover. It represents a collection of refereed research papers and survey articles written by eminent scientist on advances in different fields of elliptic and parabolic partial differential equations, including singular Riemannian manifolds, spectral analysis on manifolds, nonlinear dispersive equations, Brownian motion and kernel estimates, Euler equations, porous medium type equations, pseudodifferential calculus, free boundary problems, and bifurcation analysis.

  15. Essential imposition of Neumann condition in Galerkin-Legendre elliptic solvers

    CERN Document Server

    Auteri, F; Quartapelle, L

    2003-01-01

    A new Galerkin-Legendre direct spectral solver for the Neumann problem associated with Laplace and Helmholtz operators in rectangular domains is presented. The algorithm differs from other Neumann spectral solvers by the high sparsity of the matrices, exploited in conjunction with the direct product structure of the problem. The homogeneous boundary condition is satisfied exactly by expanding the unknown variable into a polynomial basis of functions which are built upon the Legendre polynomials and have a zero slope at the interval extremes. A double diagonalization process is employed pivoting around the eigenstructure of the pentadiagonal mass matrices in both directions, instead of the full stiffness matrices encountered in the classical variational formulation of the problem with a weak natural imposition of the derivative boundary condition. Nonhomogeneous Neumann data are accounted for by means of a lifting. Numerical results are given to illustrate the performance of the proposed spectral elliptic solv...

  16. Picone-type inequalities for nonlinear elliptic equations and their applications

    Directory of Open Access Journals (Sweden)

    Takaŝi Kusano

    2001-01-01

    Full Text Available Picone-type inequalities are derived for nonlinear elliptic equations, and Sturmian comparison theorems are established as applications. Oscillation theorems for forced super-linear elliptic equations and superlinear-sublinear elliptic equations are also obtained.

  17. Weierstrass Elliptic Function Solutions to Nonlinear Evolution Equations

    International Nuclear Information System (INIS)

    Yu Jianping; Sun Yongli

    2008-01-01

    This paper is based on the relations between projection Riccati equations and Weierstrass elliptic equation, combined with the Groebner bases in the symbolic computation. Then the novel method for constructing the Weierstrass elliptic solutions to the nonlinear evolution equations is given by using the above relations

  18. Nonlinear elliptic equations of the second order

    CERN Document Server

    Han, Qing

    2016-01-01

    Nonlinear elliptic differential equations are a diverse subject with important applications to the physical and social sciences and engineering. They also arise naturally in geometry. In particular, much of the progress in the area in the twentieth century was driven by geometric applications, from the Bernstein problem to the existence of Kähler-Einstein metrics. This book, designed as a textbook, provides a detailed discussion of the Dirichlet problems for quasilinear and fully nonlinear elliptic differential equations of the second order with an emphasis on mean curvature equations and on Monge-Ampère equations. It gives a user-friendly introduction to the theory of nonlinear elliptic equations with special attention given to basic results and the most important techniques. Rather than presenting the topics in their full generality, the book aims at providing self-contained, clear, and "elementary" proofs for results in important special cases. This book will serve as a valuable resource for graduate stu...

  19. Preconditioned steepest descent methods for some nonlinear elliptic equations involving p-Laplacian terms

    Energy Technology Data Exchange (ETDEWEB)

    Feng, Wenqiang, E-mail: wfeng1@vols.utk.edu [Department of Mathematics, The University of Tennessee, Knoxville, TN 37996 (United States); Salgado, Abner J., E-mail: asalgad1@utk.edu [Department of Mathematics, The University of Tennessee, Knoxville, TN 37996 (United States); Wang, Cheng, E-mail: cwang1@umassd.edu [Department of Mathematics, The University of Massachusetts, North Dartmouth, MA 02747 (United States); Wise, Steven M., E-mail: swise1@utk.edu [Department of Mathematics, The University of Tennessee, Knoxville, TN 37996 (United States)

    2017-04-01

    We describe and analyze preconditioned steepest descent (PSD) solvers for fourth and sixth-order nonlinear elliptic equations that include p-Laplacian terms on periodic domains in 2 and 3 dimensions. The highest and lowest order terms of the equations are constant-coefficient, positive linear operators, which suggests a natural preconditioning strategy. Such nonlinear elliptic equations often arise from time discretization of parabolic equations that model various biological and physical phenomena, in particular, liquid crystals, thin film epitaxial growth and phase transformations. The analyses of the schemes involve the characterization of the strictly convex energies associated with the equations. We first give a general framework for PSD in Hilbert spaces. Based on certain reasonable assumptions of the linear pre-conditioner, a geometric convergence rate is shown for the nonlinear PSD iteration. We then apply the general theory to the fourth and sixth-order problems of interest, making use of Sobolev embedding and regularity results to confirm the appropriateness of our pre-conditioners for the regularized p-Lapacian problems. Our results include a sharper theoretical convergence result for p-Laplacian systems compared to what may be found in existing works. We demonstrate rigorously how to apply the theory in the finite dimensional setting using finite difference discretization methods. Numerical simulations for some important physical application problems – including thin film epitaxy with slope selection and the square phase field crystal model – are carried out to verify the efficiency of the scheme.

  20. On the computational efficiency of isogeometric methods for smooth elliptic problems using direct solvers

    KAUST Repository

    Collier, Nathan; Dalcin, Lisandro; Calo, Victor M.

    2014-01-01

    SUMMARY: We compare the computational efficiency of isogeometric Galerkin and collocation methods for partial differential equations in the asymptotic regime. We define a metric to identify when numerical experiments have reached this regime. We then apply these ideas to analyze the performance of different isogeometric discretizations, which encompass C0 finite element spaces and higher-continuous spaces. We derive convergence and cost estimates in terms of the total number of degrees of freedom and then perform an asymptotic numerical comparison of the efficiency of these methods applied to an elliptic problem. These estimates are derived assuming that the underlying solution is smooth, the full Gauss quadrature is used in each non-zero knot span and the numerical solution of the discrete system is found using a direct multi-frontal solver. We conclude that under the assumptions detailed in this paper, higher-continuous basis functions provide marginal benefits.

  1. On the computational efficiency of isogeometric methods for smooth elliptic problems using direct solvers

    KAUST Repository

    Collier, Nathan

    2014-09-17

    SUMMARY: We compare the computational efficiency of isogeometric Galerkin and collocation methods for partial differential equations in the asymptotic regime. We define a metric to identify when numerical experiments have reached this regime. We then apply these ideas to analyze the performance of different isogeometric discretizations, which encompass C0 finite element spaces and higher-continuous spaces. We derive convergence and cost estimates in terms of the total number of degrees of freedom and then perform an asymptotic numerical comparison of the efficiency of these methods applied to an elliptic problem. These estimates are derived assuming that the underlying solution is smooth, the full Gauss quadrature is used in each non-zero knot span and the numerical solution of the discrete system is found using a direct multi-frontal solver. We conclude that under the assumptions detailed in this paper, higher-continuous basis functions provide marginal benefits.

  2. Adaptive Algebraic Multigrid for Finite Element Elliptic Equations with Random Coefficients

    Energy Technology Data Exchange (ETDEWEB)

    Kalchev, D

    2012-04-02

    This thesis presents a two-grid algorithm based on Smoothed Aggregation Spectral Element Agglomeration Algebraic Multigrid (SA-{rho}AMGe) combined with adaptation. The aim is to build an efficient solver for the linear systems arising from discretization of second-order elliptic partial differential equations (PDEs) with stochastic coefficients. Examples include PDEs that model subsurface flow with random permeability field. During a Markov Chain Monte Carlo (MCMC) simulation process, that draws PDE coefficient samples from a certain distribution, the PDE coefficients change, hence the resulting linear systems to be solved change. At every such step the system (discretized PDE) needs to be solved and the computed solution used to evaluate some functional(s) of interest that then determine if the coefficient sample is acceptable or not. The MCMC process is hence computationally intensive and requires the solvers used to be efficient and fast. This fact that at every step of MCMC the resulting linear system changes, makes an already existing solver built for the old problem perhaps not as efficient for the problem corresponding to the new sampled coefficient. This motivates the main goal of our study, namely, to adapt an already existing solver to handle the problem (with changed coefficient) with the objective to achieve this goal to be faster and more efficient than building a completely new solver from scratch. Our approach utilizes the local element matrices (for the problem with changed coefficients) to build local problems associated with constructed by the method agglomerated elements (a set of subdomains that cover the given computational domain). We solve a generalized eigenproblem for each set in a subspace spanned by the previous local coarse space (used for the old solver) and a vector, component of the error, that the old solver cannot handle. A portion of the spectrum of these local eigen-problems (corresponding to eigenvalues close to zero) form the

  3. Nonlinear elliptic equations and nonassociative algebras

    CERN Document Server

    Nadirashvili, Nikolai; Vlăduţ, Serge

    2014-01-01

    This book presents applications of noncommutative and nonassociative algebras to constructing unusual (nonclassical and singular) solutions to fully nonlinear elliptic partial differential equations of second order. The methods described in the book are used to solve a longstanding problem of the existence of truly weak, nonsmooth viscosity solutions. Moreover, the authors provide an almost complete description of homogeneous solutions to fully nonlinear elliptic equations. It is shown that even in the very restricted setting of "Hessian equations", depending only on the eigenvalues of the Hessian, these equations admit homogeneous solutions of all orders compatible with known regularity for viscosity solutions provided the space dimension is five or larger. To the contrary, in dimension four or less the situation is completely different, and our results suggest strongly that there are no nonclassical homogeneous solutions at all in dimensions three and four. Thus this book gives a complete list of dimensions...

  4. Elliptic and parabolic equations for measures

    Energy Technology Data Exchange (ETDEWEB)

    Bogachev, Vladimir I [M. V. Lomonosov Moscow State University, Moscow (Russian Federation); Krylov, Nikolai V [University of Minnesota, Minneapolis, MN (United States); Roeckner, Michael [Universitat Bielefeld, Bielefeld (Germany)

    2009-12-31

    This article gives a detailed account of recent investigations of weak elliptic and parabolic equations for measures with unbounded and possibly singular coefficients. The existence and differentiability of densities are studied, and lower and upper bounds for them are discussed. Semigroups associated with second-order elliptic operators acting in L{sup p}-spaces with respect to infinitesimally invariant measures are investigated. Bibliography: 181 titles.

  5. Jacobi Elliptic Solutions for Nonlinear Differential Difference Equations in Mathematical Physics

    Directory of Open Access Journals (Sweden)

    Khaled A. Gepreel

    2012-01-01

    Full Text Available We put a direct new method to construct the rational Jacobi elliptic solutions for nonlinear differential difference equations which may be called the rational Jacobi elliptic functions method. We use the rational Jacobi elliptic function method to construct many new exact solutions for some nonlinear differential difference equations in mathematical physics via the lattice equation and the discrete nonlinear Schrodinger equation with a saturable nonlinearity. The proposed method is more effective and powerful to obtain the exact solutions for nonlinear differential difference equations.

  6. The auxiliary elliptic-like equation and the exp-function method

    Indian Academy of Sciences (India)

    exact solutions of the nonlinear evolution equations are derived with the aid of auxiliary elliptic-like equation. ... (NEE) have been paid attention by many researchers, especially the investigations of exact solutions for ... elliptic-like equation with the aid of the travelling wave reduction are introduced. The exact solutions of ...

  7. Comparing direct and iterative equation solvers in a large structural analysis software system

    Science.gov (United States)

    Poole, E. L.

    1991-01-01

    Two direct Choleski equation solvers and two iterative preconditioned conjugate gradient (PCG) equation solvers used in a large structural analysis software system are described. The two direct solvers are implementations of the Choleski method for variable-band matrix storage and sparse matrix storage. The two iterative PCG solvers include the Jacobi conjugate gradient method and an incomplete Choleski conjugate gradient method. The performance of the direct and iterative solvers is compared by solving several representative structural analysis problems. Some key factors affecting the performance of the iterative solvers relative to the direct solvers are identified.

  8. Accelerated Cyclic Reduction: A Distributed-Memory Fast Solver for Structured Linear Systems

    KAUST Repository

    Chávez, Gustavo

    2017-12-15

    We present Accelerated Cyclic Reduction (ACR), a distributed-memory fast solver for rank-compressible block tridiagonal linear systems arising from the discretization of elliptic operators, developed here for three dimensions. Algorithmic synergies between Cyclic Reduction and hierarchical matrix arithmetic operations result in a solver that has O(kNlogN(logN+k2)) arithmetic complexity and O(k Nlog N) memory footprint, where N is the number of degrees of freedom and k is the rank of a block in the hierarchical approximation, and which exhibits substantial concurrency. We provide a baseline for performance and applicability by comparing with the multifrontal method with and without hierarchical semi-separable matrices, with algebraic multigrid and with the classic cyclic reduction method. Over a set of large-scale elliptic systems with features of nonsymmetry and indefiniteness, the robustness of the direct solvers extends beyond that of the multigrid solver, and relative to the multifrontal approach ACR has lower or comparable execution time and size of the factors, with substantially lower numerical ranks. ACR exhibits good strong and weak scaling in a distributed context and, as with any direct solver, is advantageous for problems that require the solution of multiple right-hand sides. Numerical experiments show that the rank k patterns are of O(1) for the Poisson equation and of O(n) for the indefinite Helmholtz equation. The solver is ideal in situations where low-accuracy solutions are sufficient, or otherwise as a preconditioner within an iterative method.

  9. Accelerated Cyclic Reduction: A Distributed-Memory Fast Solver for Structured Linear Systems

    KAUST Repository

    Chá vez, Gustavo; Turkiyyah, George; Zampini, Stefano; Ltaief, Hatem; Keyes, David E.

    2017-01-01

    We present Accelerated Cyclic Reduction (ACR), a distributed-memory fast solver for rank-compressible block tridiagonal linear systems arising from the discretization of elliptic operators, developed here for three dimensions. Algorithmic synergies between Cyclic Reduction and hierarchical matrix arithmetic operations result in a solver that has O(kNlogN(logN+k2)) arithmetic complexity and O(k Nlog N) memory footprint, where N is the number of degrees of freedom and k is the rank of a block in the hierarchical approximation, and which exhibits substantial concurrency. We provide a baseline for performance and applicability by comparing with the multifrontal method with and without hierarchical semi-separable matrices, with algebraic multigrid and with the classic cyclic reduction method. Over a set of large-scale elliptic systems with features of nonsymmetry and indefiniteness, the robustness of the direct solvers extends beyond that of the multigrid solver, and relative to the multifrontal approach ACR has lower or comparable execution time and size of the factors, with substantially lower numerical ranks. ACR exhibits good strong and weak scaling in a distributed context and, as with any direct solver, is advantageous for problems that require the solution of multiple right-hand sides. Numerical experiments show that the rank k patterns are of O(1) for the Poisson equation and of O(n) for the indefinite Helmholtz equation. The solver is ideal in situations where low-accuracy solutions are sufficient, or otherwise as a preconditioner within an iterative method.

  10. Convergence criteria for systems of nonlinear elliptic partial differential equations

    International Nuclear Information System (INIS)

    Sharma, R.K.

    1986-01-01

    This thesis deals with convergence criteria for a special system of nonlinear elliptic partial differential equations. A fixed-point algorithm is used, which iteratively solves one linearized elliptic partial differential equation at a time. Conditions are established that help foresee the convergence of the algorithm. Under reasonable hypotheses it is proved that the algorithm converges for such nonlinear elliptic systems. Extensive experimental results are reported and they show the algorithm converges in a wide variety of cases and the convergence is well correlated with the theoretical conditions introduced in this thesis

  11. Some new exact solutions of Jacobian elliptic function about the generalized Boussinesq equation and Boussinesq-Burgers equation

    International Nuclear Information System (INIS)

    Zhang Liang; Zhang Lifeng; Li Chongyin

    2008-01-01

    By using the modified mapping method, we find some new exact solutions of the generalized Boussinesq equation and the Boussinesq-Burgers equation. The solutions obtained in this paper include Jacobian elliptic function solutions, combined Jacobian elliptic function solutions, soliton solutions, triangular function solutions

  12. Self-correcting Multigrid Solver

    International Nuclear Information System (INIS)

    Lewandowski, Jerome L.V.

    2004-01-01

    A new multigrid algorithm based on the method of self-correction for the solution of elliptic problems is described. The method exploits information contained in the residual to dynamically modify the source term (right-hand side) of the elliptic problem. It is shown that the self-correcting solver is more efficient at damping the short wavelength modes of the algebraic error than its standard equivalent. When used in conjunction with a multigrid method, the resulting solver displays an improved convergence rate with no additional computational work

  13. Elliptic differential equations theory and numerical treatment

    CERN Document Server

    Hackbusch, Wolfgang

    2017-01-01

    This book simultaneously presents the theory and the numerical treatment of elliptic boundary value problems, since an understanding of the theory is necessary for the numerical analysis of the discretisation. It first discusses the Laplace equation and its finite difference discretisation before addressing the general linear differential equation of second order. The variational formulation together with the necessary background from functional analysis provides the basis for the Galerkin and finite-element methods, which are explored in detail. A more advanced chapter leads the reader to the theory of regularity. Individual chapters are devoted to singularly perturbed as well as to elliptic eigenvalue problems. The book also presents the Stokes problem and its discretisation as an example of a saddle-point problem taking into account its relevance to applications in fluid dynamics.

  14. libmpdata++ 1.0: a library of parallel MPDATA solvers for systems of generalised transport equations

    Science.gov (United States)

    Jaruga, A.; Arabas, S.; Jarecka, D.; Pawlowska, H.; Smolarkiewicz, P. K.; Waruszewski, M.

    2015-04-01

    This paper accompanies the first release of libmpdata++, a C++ library implementing the multi-dimensional positive-definite advection transport algorithm (MPDATA) on regular structured grid. The library offers basic numerical solvers for systems of generalised transport equations. The solvers are forward-in-time, conservative and non-linearly stable. The libmpdata++ library covers the basic second-order-accurate formulation of MPDATA, its third-order variant, the infinite-gauge option for variable-sign fields and a flux-corrected transport extension to guarantee non-oscillatory solutions. The library is equipped with a non-symmetric variational elliptic solver for implicit evaluation of pressure gradient terms. All solvers offer parallelisation through domain decomposition using shared-memory parallelisation. The paper describes the library programming interface, and serves as a user guide. Supported options are illustrated with benchmarks discussed in the MPDATA literature. Benchmark descriptions include code snippets as well as quantitative representations of simulation results. Examples of applications include homogeneous transport in one, two and three dimensions in Cartesian and spherical domains; a shallow-water system compared with analytical solution (originally derived for a 2-D case); and a buoyant convection problem in an incompressible Boussinesq fluid with interfacial instability. All the examples are implemented out of the library tree. Regardless of the differences in the problem dimensionality, right-hand-side terms, boundary conditions and parallelisation approach, all the examples use the same unmodified library, which is a key goal of libmpdata++ design. The design, based on the principle of separation of concerns, prioritises the user and developer productivity. The libmpdata++ library is implemented in C++, making use of the Blitz++ multi-dimensional array containers, and is released as free/libre and open-source software.

  15. libmpdata++ 0.1: a library of parallel MPDATA solvers for systems of generalised transport equations

    Science.gov (United States)

    Jaruga, A.; Arabas, S.; Jarecka, D.; Pawlowska, H.; Smolarkiewicz, P. K.; Waruszewski, M.

    2014-11-01

    This paper accompanies first release of libmpdata++, a C++ library implementing the Multidimensional Positive-Definite Advection Transport Algorithm (MPDATA). The library offers basic numerical solvers for systems of generalised transport equations. The solvers are forward-in-time, conservative and non-linearly stable. The libmpdata++ library covers the basic second-order-accurate formulation of MPDATA, its third-order variant, the infinite-gauge option for variable-sign fields and a flux-corrected transport extension to guarantee non-oscillatory solutions. The library is equipped with a non-symmetric variational elliptic solver for implicit evaluation of pressure gradient terms. All solvers offer parallelisation through domain decomposition using shared-memory parallelisation. The paper describes the library programming interface, and serves as a user guide. Supported options are illustrated with benchmarks discussed in the MPDATA literature. Benchmark descriptions include code snippets as well as quantitative representations of simulation results. Examples of applications include: homogeneous transport in one, two and three dimensions in Cartesian and spherical domains; shallow-water system compared with analytical solution (originally derived for a 2-D case); and a buoyant convection problem in an incompressible Boussinesq fluid with interfacial instability. All the examples are implemented out of the library tree. Regardless of the differences in the problem dimensionality, right-hand-side terms, boundary conditions and parallelisation approach, all the examples use the same unmodified library, which is a key goal of libmpdata++ design. The design, based on the principle of separation of concerns, prioritises the user and developer productivity. The libmpdata++ library is implemented in C++, making use of the Blitz++ multi-dimensional array containers, and is released as free/libre and open-source software.

  16. Nonlinear elliptic partial differential equations an introduction

    CERN Document Server

    Le Dret, Hervé

    2018-01-01

    This textbook presents the essential parts of the modern theory of nonlinear partial differential equations, including the calculus of variations. After a short review of results in real and functional analysis, the author introduces the main mathematical techniques for solving both semilinear and quasilinear elliptic PDEs, and the associated boundary value problems. Key topics include infinite dimensional fixed point methods, the Galerkin method, the maximum principle, elliptic regularity, and the calculus of variations. Aimed at graduate students and researchers, this textbook contains numerous examples and exercises and provides several comments and suggestions for further study.

  17. Elliptic Diophantine equations a concrete approach via the elliptic logarithm

    CERN Document Server

    Tzanakis, Nikos

    2013-01-01

    This book presents in a unified way the beautiful and deep mathematics, both theoretical and computational, on which the explicit solution of an elliptic Diophantine equation is based. It collects numerous results and methods that are scattered in literature. Some results are even hidden behind a number of routines in software packages, like Magma. This book is suitable for students in mathematics, as well as professional mathematicians.

  18. Elliptic Painlevé equations from next-nearest-neighbor translations on the E_8^{(1)} lattice

    Science.gov (United States)

    Joshi, Nalini; Nakazono, Nobutaka

    2017-07-01

    The well known elliptic discrete Painlevé equation of Sakai is constructed by a standard translation on the E_8(1) lattice, given by nearest neighbor vectors. In this paper, we give a new elliptic discrete Painlevé equation obtained by translations along next-nearest-neighbor vectors. This equation is a generic (8-parameter) version of a 2-parameter elliptic difference equation found by reduction from Adler’s partial difference equation, the so-called Q4 equation. We also provide a projective reduction of the well known equation of Sakai.

  19. A wavelet-based PWTD algorithm-accelerated time domain surface integral equation solver

    KAUST Repository

    Liu, Yang

    2015-10-26

    © 2015 IEEE. The multilevel plane-wave time-domain (PWTD) algorithm allows for fast and accurate analysis of transient scattering from, and radiation by, electrically large and complex structures. When used in tandem with marching-on-in-time (MOT)-based surface integral equation (SIE) solvers, it reduces the computational and memory costs of transient analysis from equation and equation to equation and equation, respectively, where Nt and Ns denote the number of temporal and spatial unknowns (Ergin et al., IEEE Trans. Antennas Mag., 41, 39-52, 1999). In the past, PWTD-accelerated MOT-SIE solvers have been applied to transient problems involving half million spatial unknowns (Shanker et al., IEEE Trans. Antennas Propag., 51, 628-641, 2003). Recently, a scalable parallel PWTD-accelerated MOT-SIE solver that leverages a hiearchical parallelization strategy has been developed and successfully applied to the transient problems involving ten million spatial unknowns (Liu et. al., in URSI Digest, 2013). We further enhanced the capabilities of this solver by implementing a compression scheme based on local cosine wavelet bases (LCBs) that exploits the sparsity in the temporal dimension (Liu et. al., in URSI Digest, 2014). Specifically, the LCB compression scheme was used to reduce the memory requirement of the PWTD ray data and computational cost of operations in the PWTD translation stage.

  20. Collage-based approaches for elliptic partial differential equations inverse problems

    Science.gov (United States)

    Yodzis, Michael; Kunze, Herb

    2017-01-01

    The collage method for inverse problems has become well-established in the literature in recent years. Initial work developed a collage theorem, based upon Banach's fixed point theorem, for treating inverse problems for ordinary differential equations (ODEs). Amongst the subsequent work was a generalized collage theorem, based upon the Lax-Milgram representation theorem, useful for treating inverse problems for elliptic partial differential equations (PDEs). Each of these two different approaches can be applied to elliptic PDEs in one space dimension. In this paper, we explore and compare how the two different approaches perform for the estimation of the diffusivity for a steady-state heat equation.

  1. An alternative solver for the nodal expansion method equations - 106

    International Nuclear Information System (INIS)

    Carvalho da Silva, F.; Carlos Marques Alvim, A.; Senra Martinez, A.

    2010-01-01

    An automated procedure for nuclear reactor core design is accomplished by using a quick and accurate 3D nodal code, aiming at solving the diffusion equation, which describes the spatial neutron distribution in the reactor. This paper deals with an alternative solver for nodal expansion method (NEM), with only two inner iterations (mesh sweeps) per outer iteration, thus having the potential to reduce the time required to calculate the power distribution in nuclear reactors, but with accuracy similar to the ones found in conventional NEM. The proposed solver was implemented into a computational system which, besides solving the diffusion equation, also solves the burnup equations governing the gradual changes in material compositions of the core due to fuel depletion. Results confirm the effectiveness of the method for practical purposes. (authors)

  2. High-Order Calderón Preconditioned Time Domain Integral Equation Solvers

    KAUST Repository

    Valdes, Felipe; Ghaffari-Miab, Mohsen; Andriulli, Francesco P.; Cools, Kristof; Michielssen,

    2013-01-01

    Two high-order accurate Calderón preconditioned time domain electric field integral equation (TDEFIE) solvers are presented. In contrast to existing Calderón preconditioned time domain solvers, the proposed preconditioner allows for high-order surface representations and current expansions by using a novel set of fully-localized high-order div-and quasi curl-conforming (DQCC) basis functions. Numerical results demonstrate that the linear systems of equations obtained using the proposed basis functions converge rapidly, regardless of the mesh density and of the order of the current expansion. © 1963-2012 IEEE.

  3. High-Order Calderón Preconditioned Time Domain Integral Equation Solvers

    KAUST Repository

    Valdes, Felipe

    2013-05-01

    Two high-order accurate Calderón preconditioned time domain electric field integral equation (TDEFIE) solvers are presented. In contrast to existing Calderón preconditioned time domain solvers, the proposed preconditioner allows for high-order surface representations and current expansions by using a novel set of fully-localized high-order div-and quasi curl-conforming (DQCC) basis functions. Numerical results demonstrate that the linear systems of equations obtained using the proposed basis functions converge rapidly, regardless of the mesh density and of the order of the current expansion. © 1963-2012 IEEE.

  4. An unstructured finite volume solver for two phase water/vapour flows based on an elliptic oriented fractional step method

    International Nuclear Information System (INIS)

    Mechitoua, N.; Boucker, M.; Lavieville, J.; Pigny, S.; Serre, G.

    2003-01-01

    Based on experience gained at EDF and Cea, a more general and robust 3-dimensional (3D) multiphase flow solver has been being currently developed for over three years. This solver, based on an elliptic oriented fractional step approach, is able to simulate multicomponent/multiphase flows. Discretization follows a 3D full unstructured finite volume approach, with a collocated arrangement of all variables. The non linear behaviour between pressure and volume fractions and a symmetric treatment of all fields are taken into account in the iterative procedure, within the time step. It greatly enforces the realizability of volume fractions (i.e 0 < α < 1), without artificial numerical needs. Applications to widespread test cases as static sedimentation, water hammer and phase separation are shown to assess the accuracy and the robustness of the flow solver in different flow conditions, encountered in nuclear reactors pipes. (authors)

  5. Jacobian elliptic wave solutions for the Wadati-Segur-Ablowitz equation

    International Nuclear Information System (INIS)

    Teh, C.G.R.; Koo, W.K.; Lee, B.S.

    1996-07-01

    Jacobian elliptic travelling wave solutions for a new Hamiltonian amplitude equation determining some instabilities of modulated wave train are obtained. By a mere variation of the Jacobian elliptic parameter k 2 from zero to one, these solutions are transformed from a trivial one to the known solitary wave solutions. (author). 9 refs

  6. Continuous dependence estimates for viscosity solutions of fully nonlinear degenerate elliptic equations

    Directory of Open Access Journals (Sweden)

    Espen R. Jakobsen

    2002-05-01

    Full Text Available Using the maximum principle for semicontinuous functions [3,4], we prove a general ``continuous dependence on the nonlinearities'' estimate for bounded Holder continuous viscosity solutions of fully nonlinear degenerate elliptic equations. Furthermore, we provide existence, uniqueness, and Holder continuity results for bounded viscosity solutions of such equations. Our results are general enough to encompass Hamilton-Jacobi-Bellman-Isaacs's equations of zero-sum, two-player stochastic differential games. An immediate consequence of the results obtained herein is a rate of convergence for the vanishing viscosity method for fully nonlinear degenerate elliptic equations.

  7. An imbedding theorem and its applications in degenerate elliptic equations

    International Nuclear Information System (INIS)

    Duong Minh Duc.

    1988-06-01

    We improve the Rellich-Kondrachov theorem and apply it to study strongly degenerate and singular elliptic equations. We obtain the maximum principle, Harnacks's inequality and global regularity for solutions of those equations. (author). 11 refs

  8. A fast, high-order solver for the Grad–Shafranov equation

    International Nuclear Information System (INIS)

    Pataki, Andras; Cerfon, Antoine J.; Freidberg, Jeffrey P.; Greengard, Leslie; O’Neil, Michael

    2013-01-01

    We present a new fast solver to calculate fixed-boundary plasma equilibria in toroidally axisymmetric geometries. By combining conformal mapping with Fourier and integral equation methods on the unit disk, we show that high-order accuracy can be achieved for the solution of the equilibrium equation and its first and second derivatives. Smooth arbitrary plasma cross-sections as well as arbitrary pressure and poloidal current profiles are used as initial data for the solver. Equilibria with large Shafranov shifts can be computed without difficulty. Spectral convergence is demonstrated by comparing the numerical solution with a known exact analytic solution. A fusion-relevant example of an equilibrium with a pressure pedestal is also presented

  9. Solitons and separable elliptic solutions of the sine-Gordon equation

    International Nuclear Information System (INIS)

    Bryan, A.C.; Haines, C.R.; Stuart, A.E.G.

    1979-01-01

    It is pointed out that the two-soliton (antisoliton) solutions of the sine-Gordon equation may be obtained as limiting cases of a separable, two-parameter family of elliptic solutions. The solitons are found on the boundary of the parameter space for the elliptic solutions when the latter are considered over their usual complex domain. (Auth.)

  10. Elliptic partial differential equations

    CERN Document Server

    Han, Qing

    2011-01-01

    Elliptic Partial Differential Equations by Qing Han and FangHua Lin is one of the best textbooks I know. It is the perfect introduction to PDE. In 150 pages or so it covers an amazing amount of wonderful and extraordinary useful material. I have used it as a textbook at both graduate and undergraduate levels which is possible since it only requires very little background material yet it covers an enormous amount of material. In my opinion it is a must read for all interested in analysis and geometry, and for all of my own PhD students it is indeed just that. I cannot say enough good things abo

  11. CLASSICAL AREAS OF PHENOMENOLOGY: Material parameter equation for rotating elliptical spherical cloaks

    Science.gov (United States)

    Ma, Hua; Qu, Shao-Bo; Xu, Zhuo; Zhang, Jie-Qiu; Wang, Jia-Fu

    2009-01-01

    By using the coordinate transformation method, we have deduced the material parameter equation for rotating elliptical spherical cloaks and carried out simulation as well. The results indicate that the rotating elliptical spherical cloaking shell, which is made of meta-materials whose permittivity and permeability are governed by the equation deduced in this paper, can achieve perfect invisibility by excluding electromagnetic fields from the internal region without disturbing any external field.

  12. VCODE, Ordinary Differential Equation Solver for Stiff and Non-Stiff Problems

    International Nuclear Information System (INIS)

    Cohen, Scott D.; Hindmarsh, Alan C.

    2001-01-01

    1 - Description of program or function: CVODE is a package written in ANSI standard C for solving initial value problems for ordinary differential equations. It solves both stiff and non stiff systems. In the stiff case, it includes a variety of options for treating the Jacobian of the system, including dense and band matrix solvers, and a preconditioned Krylov (iterative) solver. 2 - Method of solution: Integration is by Adams or BDF (Backward Differentiation Formula) methods, at user option. Corrector iteration is by functional iteration or Newton iteration. For the solution of linear systems within Newton iteration, users can select a dense solver, a band solver, a diagonal approximation, or a preconditioned Generalized Minimal Residual (GMRES) solver. In the dense and band cases, the user can supply a Jacobian approximation or let CVODE generate it internally. In the GMRES case, the pre-conditioner is user-supplied

  13. Time Domain Surface Integral Equation Solvers for Quantum Corrected Electromagnetic Analysis of Plasmonic Nanostructures

    KAUST Repository

    Uysal, Ismail Enes

    2016-10-01

    Plasmonic structures are utilized in many applications ranging from bio-medicine to solar energy generation and transfer. Numerical schemes capable of solving equations of classical electrodynamics have been the method of choice for characterizing scattering properties of such structures. However, as dimensions of these plasmonic structures reduce to nanometer scale, quantum mechanical effects start to appear. These effects cannot be accurately modeled by available classical numerical methods. One of these quantum effects is the tunneling, which is observed when two structures are located within a sub-nanometer distance of each other. At these small distances electrons “jump" from one structure to another and introduce a path for electric current to flow. Classical equations of electrodynamics and the schemes used for solving them do not account for this additional current path. This limitation can be lifted by introducing an auxiliary tunnel with material properties obtained using quantum models and applying a classical solver to the structures connected by this auxiliary tunnel. Early work on this topic focused on quantum models that are generated using a simple one-dimensional wave function to find the tunneling probability and assume a simple Drude model for the permittivity of the tunnel. These tunnel models are then used together with a classical frequency domain solver. In this thesis, a time domain surface integral equation solver for quantum corrected analysis of transient plasmonic interactions is proposed. This solver has several advantages: (i) As opposed to frequency domain solvers, it provides results at a broad band of frequencies with a single simulation. (ii) As opposed to differential equation solvers, it only discretizes surfaces (reducing number of unknowns), enforces the radiation condition implicitly (increasing the accuracy), and allows for time step selection independent of spatial discretization (increasing efficiency). The quantum model

  14. FDM for Elliptic Equations with Bitsadze-Samarskii-Dirichlet Conditions

    Directory of Open Access Journals (Sweden)

    Allaberen Ashyralyev

    2012-01-01

    Full Text Available A numerical method is proposed for solving nonlocal boundary value problem for the multidimensional elliptic partial differential equation with the Bitsadze-Samarskii-Dirichlet condition. The first and second-orders of accuracy stable difference schemes for the approximate solution of this nonlocal boundary value problem are presented. The stability estimates, coercivity, and almost coercivity inequalities for solution of these schemes are established. The theoretical statements for the solutions of these nonlocal elliptic problems are supported by results of numerical examples.

  15. Domain decomposition solvers for nonlinear multiharmonic finite element equations

    KAUST Repository

    Copeland, D. M.; Langer, U.

    2010-01-01

    of a simple elliptic equation for the amplitude. This is true for linear problems, but not for nonlinear problems. However, due to the periodicity of the solution, we can expand the solution in a Fourier series. Truncating this Fourier series

  16. Boundary-value problems with free boundaries for elliptic systems of equations

    CERN Document Server

    Monakhov, V N

    1983-01-01

    This book is concerned with certain classes of nonlinear problems for elliptic systems of partial differential equations: boundary-value problems with free boundaries. The first part has to do with the general theory of boundary-value problems for analytic functions and its applications to hydrodynamics. The second presents the theory of quasiconformal mappings, along with the theory of boundary-value problems for elliptic systems of equations and applications of it to problems in the mechanics of continuous media with free boundaries: problems in subsonic gas dynamics, filtration theory, and problems in elastico-plasticity.

  17. TOPICAL REVIEW: The stability for the Cauchy problem for elliptic equations

    Science.gov (United States)

    Alessandrini, Giovanni; Rondi, Luca; Rosset, Edi; Vessella, Sergio

    2009-12-01

    We discuss the ill-posed Cauchy problem for elliptic equations, which is pervasive in inverse boundary value problems modeled by elliptic equations. We provide essentially optimal stability results, in wide generality and under substantially minimal assumptions. As a general scheme in our arguments, we show that all such stability results can be derived by the use of a single building brick, the three-spheres inequality. Due to the current absence of research funding from the Italian Ministry of University and Research, this work has been completed without any financial support.

  18. Fast multipole preconditioners for sparse matrices arising from elliptic equations

    KAUST Repository

    Ibeid, Huda

    2017-11-09

    Among optimal hierarchical algorithms for the computational solution of elliptic problems, the fast multipole method (FMM) stands out for its adaptability to emerging architectures, having high arithmetic intensity, tunable accuracy, and relaxable global synchronization requirements. We demonstrate that, beyond its traditional use as a solver in problems for which explicit free-space kernel representations are available, the FMM has applicability as a preconditioner in finite domain elliptic boundary value problems, by equipping it with boundary integral capability for satisfying conditions at finite boundaries and by wrapping it in a Krylov method for extensibility to more general operators. Here, we do not discuss the well developed applications of FMM to implement matrix-vector multiplications within Krylov solvers of boundary element methods. Instead, we propose using FMM for the volume-to-volume contribution of inhomogeneous Poisson-like problems, where the boundary integral is a small part of the overall computation. Our method may be used to precondition sparse matrices arising from finite difference/element discretizations, and can handle a broader range of scientific applications. It is capable of algebraic convergence rates down to the truncation error of the discretized PDE comparable to those of multigrid methods, and it offers potentially superior multicore and distributed memory scalability properties on commodity architecture supercomputers. Compared with other methods exploiting the low-rank character of off-diagonal blocks of the dense resolvent operator, FMM-preconditioned Krylov iteration may reduce the amount of communication because it is matrix-free and exploits the tree structure of FMM. We describe our tests in reproducible detail with freely available codes and outline directions for further extensibility.

  19. Fast multipole preconditioners for sparse matrices arising from elliptic equations

    KAUST Repository

    Ibeid, Huda; Yokota, Rio; Pestana, Jennifer; Keyes, David E.

    2017-01-01

    Among optimal hierarchical algorithms for the computational solution of elliptic problems, the fast multipole method (FMM) stands out for its adaptability to emerging architectures, having high arithmetic intensity, tunable accuracy, and relaxable global synchronization requirements. We demonstrate that, beyond its traditional use as a solver in problems for which explicit free-space kernel representations are available, the FMM has applicability as a preconditioner in finite domain elliptic boundary value problems, by equipping it with boundary integral capability for satisfying conditions at finite boundaries and by wrapping it in a Krylov method for extensibility to more general operators. Here, we do not discuss the well developed applications of FMM to implement matrix-vector multiplications within Krylov solvers of boundary element methods. Instead, we propose using FMM for the volume-to-volume contribution of inhomogeneous Poisson-like problems, where the boundary integral is a small part of the overall computation. Our method may be used to precondition sparse matrices arising from finite difference/element discretizations, and can handle a broader range of scientific applications. It is capable of algebraic convergence rates down to the truncation error of the discretized PDE comparable to those of multigrid methods, and it offers potentially superior multicore and distributed memory scalability properties on commodity architecture supercomputers. Compared with other methods exploiting the low-rank character of off-diagonal blocks of the dense resolvent operator, FMM-preconditioned Krylov iteration may reduce the amount of communication because it is matrix-free and exploits the tree structure of FMM. We describe our tests in reproducible detail with freely available codes and outline directions for further extensibility.

  20. Jacobian elliptic function expansion solutions of nonlinear stochastic equations

    International Nuclear Information System (INIS)

    Wei Caimin; Xia Zunquan; Tian Naishuo

    2005-01-01

    Jacobian elliptic function expansion method is extended and applied to construct the exact solutions of the nonlinear Wick-type stochastic partial differential equations (SPDEs) and some new exact solutions are obtained via this method and Hermite transformation

  1. A Kohn–Sham equation solver based on hexahedral finite elements

    International Nuclear Information System (INIS)

    Fang Jun; Gao Xingyu; Zhou Aihui

    2012-01-01

    We design a Kohn–Sham equation solver based on hexahedral finite element discretizations. The solver integrates three schemes proposed in this paper. The first scheme arranges one a priori locally-refined hexahedral mesh with appropriate multiresolution. The second one is a modified mass-lumping procedure which accelerates the diagonalization in the self-consistent field iteration. The third one is a finite element recovery method which enhances the eigenpair approximations with small extra work. We carry out numerical tests on each scheme to investigate the validity and efficiency, and then apply them to calculate the ground state total energies of nanosystems C 60 , C 120 , and C 275 H 172 . It is shown that our solver appears to be computationally attractive for finite element applications in electronic structure study.

  2. Fast sweeping algorithm for accurate solution of the TTI eikonal equation using factorization

    KAUST Repository

    bin Waheed, Umair; Alkhalifah, Tariq Ali

    2017-01-01

    computational domain. We address the source-singularity problem for tilted transversely isotropic (TTI) eikonal solvers using factorization. We solve a sequence of factored tilted elliptically anisotropic (TEA) eikonal equations iteratively, each time

  3. Removability of singularity for nonlinear elliptic equations with p(x-growth

    Directory of Open Access Journals (Sweden)

    Yongqiang Fu

    2013-09-01

    Full Text Available Using Moser's iteration method, we investigate the problem of removable isolated singularities for elliptic equations with p(x-type nonstandard growth. We give a sufficient condition for removability of singularity for the equations in the framework of variable exponent Sobolev spaces.

  4. A new extended elliptic equation rational expansion method and its application to (2 + 1)-dimensional Burgers equation

    International Nuclear Information System (INIS)

    Wang Baodong; Song Lina; Zhang Hongqing

    2007-01-01

    In this paper, we present a new elliptic equation rational expansion method to uniformly construct a series of exact solutions for nonlinear partial differential equations. As an application of the method, we choose the (2 + 1)-dimensional Burgers equation to illustrate the method and successfully obtain some new and more general solutions

  5. Elliptic equation for random walks. Application to transport in microporous media

    DEFF Research Database (Denmark)

    Shapiro, Alexander

    2007-01-01

    We consider a process of random walks with arbitrary residence time distribution. We show that in many cases this process may not be described by the classical (Fick) parabolic diffusion equation, but an elliptic equation. An additional term proportional to the second time derivative takes into a...

  6. A high order solver for the unbounded Poisson equation

    DEFF Research Database (Denmark)

    Hejlesen, Mads Mølholm; Rasmussen, Johannes Tophøj; Chatelain, Philippe

    2013-01-01

    . The method is extended to directly solve the derivatives of the solution to Poissonʼs equation. In this way differential operators such as the divergence or curl of the solution field can be solved to the same high order convergence without additional computational effort. The method, is applied......A high order converging Poisson solver is presented, based on the Greenʼs function solution to Poissonʼs equation subject to free-space boundary conditions. The high order convergence is achieved by formulating regularised integration kernels, analogous to a smoothing of the solution field...... and validated, however not restricted, to the equations of fluid mechanics, and can be used in many applications to solve Poissonʼs equation on a rectangular unbounded domain....

  7. Numerical computation of space-charge fields of electron bunches in a beam pipe of elliptical shape

    Energy Technology Data Exchange (ETDEWEB)

    Markovik, A.

    2005-09-28

    This work deals in particularly with 3D numerical simulations of space-charge fields from electron bunches in a beam pipe with elliptical cross-section. To obtain the space-charge fields it is necessary to calculate the Poisson equation with given boundary condition and space charge distribution. The discretization of the Poisson equation by the method of finite differences on a Cartesian grid, as well as setting up the coefficient matrix A for the elliptical domain are explained in the section 2. In the section 3 the properties of the coefficient matrix and possible numerical algorithms suitable for solving non-symmetrical linear systems of equations are introduced. In the following section 4, the applied solver algorithms are investigated by numerical tests with right hand side function for which the analytical solution is known. (orig.)

  8. Numerical computation of space-charge fields of electron bunches in a beam pipe of elliptical shape

    International Nuclear Information System (INIS)

    Markovik, A.

    2005-01-01

    This work deals in particularly with 3D numerical simulations of space-charge fields from electron bunches in a beam pipe with elliptical cross-section. To obtain the space-charge fields it is necessary to calculate the Poisson equation with given boundary condition and space charge distribution. The discretization of the Poisson equation by the method of finite differences on a Cartesian grid, as well as setting up the coefficient matrix A for the elliptical domain are explained in the section 2. In the section 3 the properties of the coefficient matrix and possible numerical algorithms suitable for solving non-symmetrical linear systems of equations are introduced. In the following section 4, the applied solver algorithms are investigated by numerical tests with right hand side function for which the analytical solution is known. (orig.)

  9. The elliptic sine-Gordon equation in a half plane

    International Nuclear Information System (INIS)

    Pelloni, B; Pinotsis, D A

    2010-01-01

    We consider boundary value problems for the elliptic sine-Gordon equation posed in the half plane y > 0. This problem was considered in Gutshabash and Lipovskii (1994 J. Math. Sci. 68 197–201) using the classical inverse scattering transform approach. Given the limitations of this approach, the results obtained rely on a nonlinear constraint on the spectral data derived heuristically by analogy with the linearized case. We revisit the analysis of such problems using a recent generalization of the inverse scattering transform known as the Fokas method, and show that the nonlinear constraint of Gutshabash and Lipovskii (1994 J. Math. Sci. 68 197–201) is a consequence of the so-called global relation. We also show that this relation implies a stronger constraint on the spectral data, and in particular that no choice of boundary conditions can be associated with a decaying (possibly mod 2π) solution analogous to the pure soliton solutions of the usual, time-dependent sine-Gordon equation. We also briefly indicate how, in contrast to the evolutionary case, the elliptic sine-Gordon equation posed in the half plane does not admit linearisable boundary conditions

  10. Optimal Control for the Degenerate Elliptic Logistic Equation

    International Nuclear Information System (INIS)

    Delgado, M.; Montero, J.A.; Suarez, A.

    2002-01-01

    We consider the optimal control of harvesting the diffusive degenerate elliptic logistic equation. Under certain assumptions, we prove the existence and uniqueness of an optimal control. Moreover, the optimality system and a characterization of the optimal control are also derived. The sub-supersolution method, the singular eigenvalue problem and differentiability with respect to the positive cone are the techniques used to obtain our results

  11. RECTC/RECTCF, 2. Order Elliptical Partial Differential Equation, Arbitrary Boundary Conditions

    International Nuclear Information System (INIS)

    Hackbusch, W.

    1983-01-01

    1 - Description of problem or function: A general linear elliptical second order partial differential equation on a rectangle with arbitrary boundary conditions is solved. 2 - Method of solution: Multi-grid iteration

  12. Preconditioners based on windowed Fourier frames applied to elliptic partial differential equations

    NARCIS (Netherlands)

    Bhowmik, S.K.; Stolk, C.C.

    2011-01-01

    We investigate the application of windowed Fourier frames to the numerical solution of partial differential equations, focussing on elliptic equations. The action of a partial differential operator (PDO) on a windowed plane wave is close to a multiplication, where the multiplication factor is given

  13. On a class of strongly degenerate and singular linear elliptic equation

    International Nuclear Information System (INIS)

    Duong Minh Duc, D.M.; Le Dung.

    1992-11-01

    We consider a class of strongly degenerate linear elliptic equation. The boundedness and the Holder regularity of the weak solutions in the weighted Sobolev-Hardy spaces will be studied. (author). 9 refs

  14. Telescopic Hybrid Fast Solver for 3D Elliptic Problems with Point Singularities

    KAUST Repository

    Paszyńska, Anna; Jopek, Konrad; Banaś, Krzysztof; Paszyński, Maciej; Gurgul, Piotr; Lenerth, Andrew; Nguyen, Donald; Pingali, Keshav; Dalcind, Lisandro; Calo, Victor M.

    2015-01-01

    This paper describes a telescopic solver for two dimensional h adaptive grids with point singularities. The input for the telescopic solver is an h refined two dimensional computational mesh with rectangular finite elements. The candidates for point singularities are first localized over the mesh by using a greedy algorithm. Having the candidates for point singularities, we execute either a direct solver, that performs multiple refinements towards selected point singularities and executes a parallel direct solver algorithm which has logarithmic cost with respect to refinement level. The direct solvers executed over each candidate for point singularity return local Schur complement matrices that can be merged together and submitted to iterative solver. In this paper we utilize a parallel multi-thread GALOIS solver as a direct solver. We use Incomplete LU Preconditioned Conjugated Gradients (ILUPCG) as an iterative solver. We also show that elimination of point singularities from the refined mesh reduces significantly the number of iterations to be performed by the ILUPCG iterative solver.

  15. Telescopic Hybrid Fast Solver for 3D Elliptic Problems with Point Singularities

    KAUST Repository

    Paszyńska, Anna

    2015-06-01

    This paper describes a telescopic solver for two dimensional h adaptive grids with point singularities. The input for the telescopic solver is an h refined two dimensional computational mesh with rectangular finite elements. The candidates for point singularities are first localized over the mesh by using a greedy algorithm. Having the candidates for point singularities, we execute either a direct solver, that performs multiple refinements towards selected point singularities and executes a parallel direct solver algorithm which has logarithmic cost with respect to refinement level. The direct solvers executed over each candidate for point singularity return local Schur complement matrices that can be merged together and submitted to iterative solver. In this paper we utilize a parallel multi-thread GALOIS solver as a direct solver. We use Incomplete LU Preconditioned Conjugated Gradients (ILUPCG) as an iterative solver. We also show that elimination of point singularities from the refined mesh reduces significantly the number of iterations to be performed by the ILUPCG iterative solver.

  16. Elliptic Euler–Poisson–Darboux equation, critical points and integrable systems

    International Nuclear Information System (INIS)

    Konopelchenko, B G; Ortenzi, G

    2013-01-01

    The structure and properties of families of critical points for classes of functions W(z, z-bar ) obeying the elliptic Euler–Poisson–Darboux equation E(1/2, 1/2) are studied. General variational and differential equations governing the dependence of critical points in variational (deformation) parameters are found. Explicit examples of the corresponding integrable quasi-linear differential systems and hierarchies are presented. There are the extended dispersionless Toda/nonlinear Schrödinger hierarchies, the ‘inverse’ hierarchy and equations associated with the real-analytic Eisenstein series E(β, β-bar ;1/2) among them. The specific bi-Hamiltonian structure of these equations is also discussed. (paper)

  17. Boundary conditions for the numerical solution of elliptic equations in exterior regions

    International Nuclear Information System (INIS)

    Bayliss, A.; Gunzburger, M.; Turkel, E.

    1982-01-01

    Elliptic equations in exterior regions frequently require a boundary condition at infinity to ensure the well-posedness of the problem. Examples of practical applications include the Helmholtz equation and Laplace's equation. Computational procedures based on a direct discretization of the elliptic problem require the replacement of the condition at infinity by a boundary condition on a finite artificial surface. Direct imposition of the condition at infinity along the finite boundary results in large errors. A sequence of boundary conditions is developed which provides increasingly accurate approximations to the problem in the infinite domain. Estimates of the error due to the finite boundary are obtained for several cases. Computations are presented which demonstrate the increased accuracy that can be obtained by the use of the higher order boundary conditions. The examples are based on a finite element formulation but finite difference methods can also be used

  18. Transient analysis of electromagnetic wave interactions on plasmonic nanostructures using a surface integral equation solver

    KAUST Repository

    Uysal, Ismail Enes

    2016-08-09

    Transient electromagnetic interactions on plasmonic nanostructures are analyzed by solving the Poggio-Miller-Chan-Harrington-Wu-Tsai (PMCHWT) surface integral equation (SIE). Equivalent (unknown) electric and magnetic current densities, which are introduced on the surfaces of the nanostructures, are expanded using Rao-Wilton-Glisson and polynomial basis functions in space and time, respectively. Inserting this expansion into the PMCHWT-SIE and Galerkin testing the resulting equation at discrete times yield a system of equations that is solved for the current expansion coefficients by a marching on-in-time (MOT) scheme. The resulting MOT-PMCHWT-SIE solver calls for computation of additional convolutions between the temporal basis function and the plasmonic medium\\'s permittivity and Green function. This computation is carried out with almost no additional cost and without changing the computational complexity of the solver. Time-domain samples of the permittivity and the Green function required by these convolutions are obtained from their frequency-domain samples using a fast relaxed vector fitting algorithm. Numerical results demonstrate the accuracy and applicability of the proposed MOT-PMCHWT solver. © 2016 Optical Society of America.

  19. Radial solutions to semilinear elliptic equations via linearized operators

    Directory of Open Access Journals (Sweden)

    Phuong Le

    2017-04-01

    Full Text Available Let $u$ be a classical solution of semilinear elliptic equations in a ball or an annulus in $\\mathbb{R}^N$ with zero Dirichlet boundary condition where the nonlinearity has a convex first derivative. In this note, we prove that if the $N$-th eigenvalue of the linearized operator at $u$ is positive, then $u$ must be radially symmetric.

  20. Elliptic equation rational expansion method and new exact travelling solutions for Whitham-Broer-Kaup equations

    International Nuclear Information System (INIS)

    Chen Yong; Wang Qi; Li Biao

    2005-01-01

    Based on a new general ansatz and a general subepuation, a new general algebraic method named elliptic equation rational expansion method is devised for constructing multiple travelling wave solutions in terms of rational special function for nonlinear evolution equations (NEEs). We apply the proposed method to solve Whitham-Broer-Kaup equation and explicitly construct a series of exact solutions which include rational form solitary wave solution, rational form triangular periodic wave solutions and rational wave solutions as special cases. In addition, the links among our proposed method with the method by Fan [Chaos, Solitons and Fractals 2004;20:609], are also clarified generally

  1. Parallelization of pressure equation solver for incompressible N-S equations

    International Nuclear Information System (INIS)

    Ichihara, Kiyoshi; Yokokawa, Mitsuo; Kaburaki, Hideo.

    1996-03-01

    A pressure equation solver in a code for 3-dimensional incompressible flow analysis has been parallelized by using red-black SOR method and PCG method on Fujitsu VPP500, a vector parallel computer with distributed memory. For the comparison of scalability, the solver using the red-black SOR method has been also parallelized on the Intel Paragon, a scalar parallel computer with a distributed memory. The scalability of the red-black SOR method on both VPP500 and Paragon was lost, when number of processor elements was increased. The reason of non-scalability on both systems is increasing communication time between processor elements. In addition, the parallelization by DO-loop division makes the vectorizing efficiency lower on VPP500. For an effective implementation on VPP500, a large scale problem which holds very long vectorized DO-loops in the parallel program should be solved. PCG method with red-black SOR method applied to incomplete LU factorization (red-black PCG) has more iteration steps than normal PCG method with forward and backward substitution, in spite of same number of the floating point operations in a DO-loop of incomplete LU factorization. The parallelized red-black PCG method has less merits than the parallelized red-black SOR method when the computational region has fewer grids, because the low vectorization efficiency is obtained in red-black PCG method. (author)

  2. POSSOL, 2-D Poisson Equation Solver for Nonuniform Grid

    International Nuclear Information System (INIS)

    Orvis, W.J.

    1988-01-01

    1 - Description of program or function: POSSOL is a two-dimensional Poisson equation solver for problems with arbitrary non-uniform gridding in Cartesian coordinates. It is an adaptation of the uniform grid PWSCRT routine developed by Schwarztrauber and Sweet at the National Center for Atmospheric Research (NCAR). 2 - Method of solution: POSSOL will solve the Helmholtz equation on an arbitrary, non-uniform grid on a rectangular domain allowing only one type of boundary condition on any one side. It can also be used to handle more than one type of boundary condition on a side by means of a capacitance matrix technique. There are three types of boundary conditions that can be applied: fixed, derivative, or periodic

  3. An extended Jacobi elliptic function rational expansion method and its application to (2+1)-dimensional dispersive long wave equation

    International Nuclear Information System (INIS)

    Wang Qi; Chen Yong; Zhang Hongqing

    2005-01-01

    With the aid of computerized symbolic computation, a new elliptic function rational expansion method is presented by means of a new general ansatz, in which periodic solutions of nonlinear partial differential equations that can be expressed as a finite Laurent series of some of 12 Jacobi elliptic functions, is more powerful than exiting Jacobi elliptic function methods and is very powerful to uniformly construct more new exact periodic solutions in terms of rational formal Jacobi elliptic function solution of nonlinear partial differential equations. As an application of the method, we choose a (2+1)-dimensional dispersive long wave equation to illustrate the method. As a result, we can successfully obtain the solutions found by most existing Jacobi elliptic function methods and find other new and more general solutions at the same time. Of course, more shock wave solutions or solitary wave solutions can be gotten at their limit condition

  4. Visualising magnetic fields numerical equation solvers in action

    CERN Document Server

    Beeteson, John Stuart

    2001-01-01

    Visualizing Magnetic Fields: Numerical Equation Solvers in Action provides a complete description of the theory behind a new technique, a detailed discussion of the ways of solving the equations (including a software visualization of the solution algorithms), the application software itself, and the full source code. Most importantly, there is a succinct, easy-to-follow description of each procedure in the code.The physicist Michael Faraday said that the study of magnetic lines of force was greatly influential in leading him to formulate many of those concepts that are now so fundamental to our modern world, proving to him their "great utility as well as fertility." Michael Faraday could only visualize these lines in his mind's eye and, even with modern computers to help us, it has been very expensive and time consuming to plot lines of force in magnetic fields

  5. A note on a degenerate elliptic equation with applications for lakes and seas

    Directory of Open Access Journals (Sweden)

    Didier Bresch

    2004-03-01

    Full Text Available In this paper, we give an intermediate regularity result on a degenerate elliptic equation with a weight blowing up on the boundary. This kind of equations is encountoured when modelling some phenomena linked to seas or lakes. We give some examples where such regularity is useful.

  6. Generalized multiscale finite element methods. nonlinear elliptic equations

    KAUST Repository

    Efendiev, Yalchin R.; Galvis, Juan; Li, Guanglian; Presho, Michael

    2013-01-01

    In this paper we use the Generalized Multiscale Finite Element Method (GMsFEM) framework, introduced in [26], in order to solve nonlinear elliptic equations with high-contrast coefficients. The proposed solution method involves linearizing the equation so that coarse-grid quantities of previous solution iterates can be regarded as auxiliary parameters within the problem formulation. With this convention, we systematically construct respective coarse solution spaces that lend themselves to either continuous Galerkin (CG) or discontinuous Galerkin (DG) global formulations. Here, we use Symmetric Interior Penalty Discontinuous Galerkin approach. Both methods yield a predictable error decline that depends on the respective coarse space dimension, and we illustrate the effectiveness of the CG and DG formulations by offering a variety of numerical examples. © 2014 Global-Science Press.

  7. Nonlinear anisotropic elliptic equations with variable exponents and degenerate coercivity

    Directory of Open Access Journals (Sweden)

    Hocine Ayadi

    2018-02-01

    Full Text Available In this article, we prove the existence and the regularity of distributional solutions for a class of nonlinear anisotropic elliptic equations with $p_i(x$ growth conditions, degenerate coercivity and $L^{m(\\cdot}$ data, with $m(\\cdot$ being small, in appropriate Lebesgue-Sobolev spaces with variable exponents. The obtained results extend some existing ones [8,10].

  8. A Gas-Kinetic Method for Hyperbolic-Elliptic Equations and Its Application in Two-Phase Fluid Flow

    Science.gov (United States)

    Xu, Kun

    1999-01-01

    A gas-kinetic method for the hyperbolic-elliptic equations is presented in this paper. In the mixed type system, the co-existence and the phase transition between liquid and gas are described by the van der Waals-type equation of state (EOS). Due to the unstable mechanism for a fluid in the elliptic region, interface between the liquid and gas can be kept sharp through the condensation and evaporation process to remove the "averaged" numerical fluid away from the elliptic region, and the interface thickness depends on the numerical diffusion and stiffness of the phase change. A few examples are presented in this paper for both phase transition and multifluid interface problems.

  9. Optical solver for a system of ordinary differential equations based on an external feedback assisted microring resonator.

    Science.gov (United States)

    Hou, Jie; Dong, Jianji; Zhang, Xinliang

    2017-06-15

    Systems of ordinary differential equations (SODEs) are crucial for describing the dynamic behaviors in various systems such as modern control systems which require observability and controllability. In this Letter, we propose and experimentally demonstrate an all-optical SODE solver based on the silicon-on-insulator platform. We use an add/drop microring resonator to construct two different ordinary differential equations (ODEs) and then introduce two external feedback waveguides to realize the coupling between these ODEs, thus forming the SODE solver. A temporal coupled mode theory is used to deduce the expression of the SODE. A system experiment is carried out for further demonstration. For the input 10 GHz NRZ-like pulses, the measured output waveforms of the SODE solver agree well with the calculated results.

  10. Compact tunable silicon photonic differential-equation solver for general linear time-invariant systems.

    Science.gov (United States)

    Wu, Jiayang; Cao, Pan; Hu, Xiaofeng; Jiang, Xinhong; Pan, Ting; Yang, Yuxing; Qiu, Ciyuan; Tremblay, Christine; Su, Yikai

    2014-10-20

    We propose and experimentally demonstrate an all-optical temporal differential-equation solver that can be used to solve ordinary differential equations (ODEs) characterizing general linear time-invariant (LTI) systems. The photonic device implemented by an add-drop microring resonator (MRR) with two tunable interferometric couplers is monolithically integrated on a silicon-on-insulator (SOI) wafer with a compact footprint of ~60 μm × 120 μm. By thermally tuning the phase shifts along the bus arms of the two interferometric couplers, the proposed device is capable of solving first-order ODEs with two variable coefficients. The operation principle is theoretically analyzed, and system testing of solving ODE with tunable coefficients is carried out for 10-Gb/s optical Gaussian-like pulses. The experimental results verify the effectiveness of the fabricated device as a tunable photonic ODE solver.

  11. Existence of bounded solutions of Neumann problem for a nonlinear degenerate elliptic equation

    Directory of Open Access Journals (Sweden)

    Salvatore Bonafede

    2017-10-01

    Full Text Available We prove the existence of bounded solutions of Neumann problem for nonlinear degenerate elliptic equations of second order in divergence form. We also study some properties as the Phragmen-Lindelof property and the asymptotic behavior of the solutions of Dirichlet problem associated to our equation in an unbounded domain.

  12. Robust and scalable hierarchical matrix-based fast direct solver and preconditioner for the numerical solution of elliptic partial differential equations

    KAUST Repository

    Chavez Chavez, Gustavo Ivan

    2017-01-01

    Numerical experiments corroborate the robustness, accuracy, and complexity claims and provide a baseline of the performance and memory footprint by comparisons with competing approaches such as the multigrid solver hypre, and the STRUMPACK implementation of the multifrontal factorization with hierarchically semi-separable matrices. The companion implementation can utilize many thousands of cores of Shaheen, KAUST's Haswell-based Cray XC-40 supercomputer, and compares favorably with other implementations of hierarchical solvers in terms of time-to-solution and memory consumption.

  13. Multilevel solvers of first-order system least-squares for Stokes equations

    Energy Technology Data Exchange (ETDEWEB)

    Lai, Chen-Yao G. [National Chung Cheng Univ., Chia-Yi (Taiwan, Province of China)

    1996-12-31

    Recently, The use of first-order system least squares principle for the approximate solution of Stokes problems has been extensively studied by Cai, Manteuffel, and McCormick. In this paper, we study multilevel solvers of first-order system least-squares method for the generalized Stokes equations based on the velocity-vorticity-pressure formulation in three dimensions. The least-squares functionals is defined to be the sum of the L{sup 2}-norms of the residuals, which is weighted appropriately by the Reynolds number. We develop convergence analysis for additive and multiplicative multilevel methods applied to the resulting discrete equations.

  14. Analysis of transient plasmonic interactions using an MOT-PMCHWT integral equation solver

    KAUST Repository

    Uysal, Ismail Enes

    2014-07-01

    Device design involving metals and dielectrics at nano-scales and optical frequencies calls for simulation tools capable of analyzing plasmonic interactions. To this end finite difference time domain (FDTD) and finite element methods have been used extensively. Since these methods require volumetric meshes, the discretization size should be very small to accurately resolve fast-decaying fields in the vicinity of metal/dielectric interfaces. This can be avoided using integral equation (IE) techniques that discretize only on the interfaces. Additionally, IE solvers implicitly enforce the radiation condition and consequently do not need (approximate) absorbing boundary conditions. Despite these advantages, IE solvers, especially in time domain, have not been used for analyzing plasmonic interactions.

  15. Fast Multipole-Based Elliptic PDE Solver and Preconditioner

    KAUST Repository

    Ibeid, Huda

    2016-01-01

    extrapolated scalability. Fast multipole methods (FMM) were originally developed for accelerating N-body problems for particle-based methods in astrophysics and molecular dynamics. FMM is more than an N-body solver, however. Recent efforts to view the FMM

  16. Modeling groundwater flow to elliptical lakes and through multi-aquifer elliptical inhomogeneities

    Science.gov (United States)

    Bakker, Mark

    2004-05-01

    Two new analytic element solutions are presented for steady flow problems with elliptical boundaries. The first solution concerns groundwater flow to shallow elliptical lakes with leaky lake beds in a single-aquifer. The second solution concerns groundwater flow through elliptical cylinder inhomogeneities in a multi-aquifer system. Both the transmissivity of each aquifer and the resistance of each leaky layer may differ between the inside and the outside of an inhomogeneity. The elliptical inhomogeneity may be bounded on top by a shallow elliptical lake with a leaky lake bed. Analytic element solutions are obtained for both problems through separation of variables of the Laplace and modified-Helmholtz differential equations in elliptical coordinates. The resulting equations for the discharge potential consist of infinite sums of products of exponentials, trigonometric functions, and modified-Mathieu functions. The series are truncated but still fulfill the differential equation exactly; boundary conditions are met approximately, but up to machine accuracy provided enough terms are used. The head and flow may be computed analytically at any point in the aquifer. Examples are given of uniform flow through an elliptical lake, a well pumping near two elliptical lakes, and uniform flow through three elliptical inhomogeneities in a multi-aquifer system. Mathieu functions may be applied in a similar fashion to solve other groundwater flow problems in semi-confined aquifers and leaky aquifer systems with elliptical internal or external boundaries.

  17. The anisotropic Ising correlations as elliptic integrals: duality and differential equations

    International Nuclear Information System (INIS)

    McCoy, B M; Maillard, J-M

    2016-01-01

    We present the reduction of the correlation functions of the Ising model on the anisotropic square lattice to complete elliptic integrals of the first, second and third kind, the extension of Kramers–Wannier duality to anisotropic correlation functions, and the linear differential equations for these anisotropic correlations. More precisely, we show that the anisotropic correlation functions are homogeneous polynomials of the complete elliptic integrals of the first, second and third kind. We give the exact dual transformation matching the correlation functions and the dual correlation functions. We show that the linear differential operators annihilating the general two-point correlation functions are factorized in a very simple way, in operators of decreasing orders. (paper)

  18. A fast Poisson solver for unsteady incompressible Navier-Stokes equations on the half-staggered grid

    Science.gov (United States)

    Golub, G. H.; Huang, L. C.; Simon, H.; Tang, W. -P.

    1995-01-01

    In this paper, a fast Poisson solver for unsteady, incompressible Navier-Stokes equations with finite difference methods on the non-uniform, half-staggered grid is presented. To achieve this, new algorithms for diagonalizing a semi-definite pair are developed. Our fast solver can also be extended to the three dimensional case. The motivation and related issues in using this second kind of staggered grid are also discussed. Numerical testing has indicated the effectiveness of this algorithm.

  19. On the solution of elliptic partial differential equations on regions with corners

    International Nuclear Information System (INIS)

    Serkh, Kirill; Rokhlin, Vladimir

    2016-01-01

    In this paper we investigate the solution of boundary value problems on polygonal domains for elliptic partial differential equations. We observe that when the problems are formulated as the boundary integral equations of classical potential theory, the solutions are representable by series of elementary functions. In addition to being analytically perspicuous, the resulting expressions lend themselves to the construction of accurate and efficient numerical algorithms. The results are illustrated by a number of numerical examples.

  20. Cartesian Mesh Linearized Euler Equations Solver for Aeroacoustic Problems around Full Aircraft

    Directory of Open Access Journals (Sweden)

    Yuma Fukushima

    2015-01-01

    Full Text Available The linearized Euler equations (LEEs solver for aeroacoustic problems has been developed on block-structured Cartesian mesh to address complex geometry. Taking advantage of the benefits of Cartesian mesh, we employ high-order schemes for spatial derivatives and for time integration. On the other hand, the difficulty of accommodating curved wall boundaries is addressed by the immersed boundary method. The resulting LEEs solver is robust to complex geometry and numerically efficient in a parallel environment. The accuracy and effectiveness of the present solver are validated by one-dimensional and three-dimensional test cases. Acoustic scattering around a sphere and noise propagation from the JT15D nacelle are computed. The results show good agreement with analytical, computational, and experimental results. Finally, noise propagation around fuselage-wing-nacelle configurations is computed as a practical example. The results show that the sound pressure level below the over-the-wing nacelle (OWN configuration is much lower than that of the conventional DLR-F6 aircraft configuration due to the shielding effect of the OWN configuration.

  1. A Direct Elliptic Solver Based on Hierarchically Low-Rank Schur Complements

    KAUST Repository

    Chávez, Gustavo

    2017-03-17

    A parallel fast direct solver for rank-compressible block tridiagonal linear systems is presented. Algorithmic synergies between Cyclic Reduction and Hierarchical matrix arithmetic operations result in a solver with O(Nlog2N) arithmetic complexity and O(NlogN) memory footprint. We provide a baseline for performance and applicability by comparing with well-known implementations of the $$\\\\mathcal{H}$$ -LU factorization and algebraic multigrid within a shared-memory parallel environment that leverages the concurrency features of the method. Numerical experiments reveal that this method is comparable with other fast direct solvers based on Hierarchical Matrices such as $$\\\\mathcal{H}$$ -LU and that it can tackle problems where algebraic multigrid fails to converge.

  2. Quasilinear Elliptic Equations with Hardy-Sobolev Critical Exponents: Existence and Multiplicity of Nontrivial Solutions

    Directory of Open Access Journals (Sweden)

    Guanwei Chen

    2014-01-01

    Full Text Available We study the existence of positive solutions and multiplicity of nontrivial solutions for a class of quasilinear elliptic equations by using variational methods. Our obtained results extend some existing ones.

  3. The Ising model: from elliptic curves to modular forms and Calabi-Yau equations

    International Nuclear Information System (INIS)

    Bostan, A; Boukraa, S; Hassani, S; Zenine, N; Van Hoeij, M; Maillard, J-M; Weil, J-A

    2011-01-01

    We show that almost all the linear differential operators factors obtained in the analysis of the n-particle contributions of the susceptibility of the Ising model for n ≤ 6 are linear differential operators associated with elliptic curves. Beyond the simplest differential operators factors which are homomorphic to symmetric powers of the second order operator associated with the complete elliptic integral E, the second and third order differential operators Z 2 , F 2 , F 3 , L-tilde 3 can actually be interpreted as modular forms of the elliptic curve of the Ising model. A last order-4 globally nilpotent linear differential operator is not reducible to this elliptic curve, modular form scheme. This operator is shown to actually correspond to a natural generalization of this elliptic curve, modular form scheme, with the emergence of a Calabi-Yau equation, corresponding to a selected 4 F 3 hypergeometric function. This hypergeometric function can also be seen as a Hadamard product of the complete elliptic integral K, with a remarkably simple algebraic pull-back (square root extension), the corresponding Calabi-Yau fourth order differential operator having a symplectic differential Galois group SP(4,C). The mirror maps and higher order Schwarzian ODEs, associated with this Calabi-Yau ODE, present all the nice physical and mathematical ingredients we had with elliptic curves and modular forms, in particular an exact (isogenies) representation of the generators of the renormalization group, extending the modular group SL(2,Z) to a GL(2,Z) symmetry group.

  4. The eigenvalue problem for a singular quasilinear elliptic equation

    Directory of Open Access Journals (Sweden)

    Benjin Xuan

    2004-02-01

    Full Text Available We show that many results about the eigenvalues and eigenfunctions of a quasilinear elliptic equation in the non-singular case can be extended to the singular case. Among these results, we have the first eigenvalue is associated to a $C^{1,alpha}(Omega$ eigenfunction which is positive and unique (up to a multiplicative constant, that is, the first eigenvalue is simple. Moreover the first eigenvalue is isolated and is the unique positive eigenvalue associated to a non-negative eigenfunction. We also prove some variational properties of the second eigenvalue.

  5. Scalability of Direct Solver for Non-stationary Cahn-Hilliard Simulations with Linearized time Integration Scheme

    KAUST Repository

    Woźniak, M.

    2016-06-02

    We study the features of a new mixed integration scheme dedicated to solving the non-stationary variational problems. The scheme is composed of the FEM approximation with respect to the space variable coupled with a 3-leveled time integration scheme with a linearized right-hand side operator. It was applied in solving the Cahn-Hilliard parabolic equation with a nonlinear, fourth-order elliptic part. The second order of the approximation along the time variable was proven. Moreover, the good scalability of the software based on this scheme was confirmed during simulations. We verify the proposed time integration scheme by monitoring the Ginzburg-Landau free energy. The numerical simulations are performed by using a parallel multi-frontal direct solver executed over STAMPEDE Linux cluster. Its scalability was compared to the results of the three direct solvers, including MUMPS, SuperLU and PaSTiX.

  6. Existence results for boundary problems for uniformly elliptic and parabolic fully nonlinear equations

    Directory of Open Access Journals (Sweden)

    M. G. Crandall

    1999-07-01

    Full Text Available We study existence of continuous weak (viscosity solutions of Dirichlet and Cauchy-Dirichlet problems for fully nonlinear uniformly elliptic and parabolic equations. Two types of results are obtained in contexts where uniqueness of solutions fails or is unknown. For equations with merely measurable coefficients we prove solvability of the problem, while in the continuous case we construct maximal and minimal solutions. Necessary barriers on external cones are also constructed.

  7. Elliptic random-walk equation for suspension and tracer transport in porous media

    DEFF Research Database (Denmark)

    Shapiro, Alexander; Bedrikovetsky, P. G.

    2008-01-01

    . The new theory predicts delay of the maximum of the tracer, compared to the velocity of the flow, while its forward "tail" contains much more particles than in the solution of the classical parabolic (advection-dispersion) equation. This is in agreement with the experimental observations and predictions......We propose a new approach to transport of the suspensions and tracers in porous media. The approach is based on a modified version of the continuous time random walk (CTRW) theory. In the framework of this theory we derive an elliptic transport equation. The new equation contains the time...... of the CTRW theory. (C) 2008 Elsevier B.V. All rights reserved....

  8. A class of strongly degenerate elliptic operators

    International Nuclear Information System (INIS)

    Duong Minh Duc.

    1988-04-01

    Using a weighted Poincare inequality, we study (ω 1 ,...,ω n )-elliptic operators. This method is applicable to solve singular elliptic equations with conditions in W 1,2 on the boundary. We also get a result about the regularity of solutions of singular elliptic equations. An application to (ω 1 ,...ω n )-parabolic equations is given. (author). 33 refs

  9. Symbolic computation of exact solutions expressible in rational formal hyperbolic and elliptic functions for nonlinear partial differential equations

    International Nuclear Information System (INIS)

    Wang Qi; Chen Yong

    2007-01-01

    With the aid of symbolic computation, some algorithms are presented for the rational expansion methods, which lead to closed-form solutions of nonlinear partial differential equations (PDEs). The new algorithms are given to find exact rational formal polynomial solutions of PDEs in terms of Jacobi elliptic functions, solutions of the Riccati equation and solutions of the generalized Riccati equation. They can be implemented in symbolic computation system Maple. As applications of the methods, we choose some nonlinear PDEs to illustrate the methods. As a result, we not only can successfully obtain the solutions found by most existing Jacobi elliptic function methods and Tanh-methods, but also find other new and more general solutions at the same time

  10. The Application Strategy of Iterative Solution Methodology to Matrix Equations in Hydraulic Solver Package, SPACE

    International Nuclear Information System (INIS)

    Na, Y. W.; Park, C. E.; Lee, S. Y.

    2009-01-01

    main object of this work is not to investigate the whole transient behavior of the models at hand but to focus on the behavior of numerical solutions part of the sparse asymmetric matrix equations in the transient of hydraulic system. It is outside of the scope of this work to improve the diagonal dominance or to pre-condition the matrix in the process of differencing and linearizing the governing equation, even though it is better to do it that way before applying the solver if there is any efficient way available

  11. Parallel Computation of the Jacobian Matrix for Nonlinear Equation Solvers Using MATLAB

    Science.gov (United States)

    Rose, Geoffrey K.; Nguyen, Duc T.; Newman, Brett A.

    2017-01-01

    Demonstrating speedup for parallel code on a multicore shared memory PC can be challenging in MATLAB due to underlying parallel operations that are often opaque to the user. This can limit potential for improvement of serial code even for the so-called embarrassingly parallel applications. One such application is the computation of the Jacobian matrix inherent to most nonlinear equation solvers. Computation of this matrix represents the primary bottleneck in nonlinear solver speed such that commercial finite element (FE) and multi-body-dynamic (MBD) codes attempt to minimize computations. A timing study using MATLAB's Parallel Computing Toolbox was performed for numerical computation of the Jacobian. Several approaches for implementing parallel code were investigated while only the single program multiple data (spmd) method using composite objects provided positive results. Parallel code speedup is demonstrated but the goal of linear speedup through the addition of processors was not achieved due to PC architecture.

  12. Coercive properties of elliptic-parabolic operator

    International Nuclear Information System (INIS)

    Duong Min Duc.

    1987-06-01

    Using a generalized Poincare inequality, we study the coercive properties of a class of elliptic-parabolic partial differential equations, which contains many degenerate elliptic equations considered by the other authors. (author). 16 refs

  13. Fast linear solver for radiative transport equation with multiple right hand sides in diffuse optical tomography

    International Nuclear Information System (INIS)

    Jia, Jingfei; Kim, Hyun K.; Hielscher, Andreas H.

    2015-01-01

    It is well known that radiative transfer equation (RTE) provides more accurate tomographic results than its diffusion approximation (DA). However, RTE-based tomographic reconstruction codes have limited applicability in practice due to their high computational cost. In this article, we propose a new efficient method for solving the RTE forward problem with multiple light sources in an all-at-once manner instead of solving it for each source separately. To this end, we introduce here a novel linear solver called block biconjugate gradient stabilized method (block BiCGStab) that makes full use of the shared information between different right hand sides to accelerate solution convergence. Two parallelized block BiCGStab methods are proposed for additional acceleration under limited threads situation. We evaluate the performance of this algorithm with numerical simulation studies involving the Delta–Eddington approximation to the scattering phase function. The results show that the single threading block RTE solver proposed here reduces computation time by a factor of 1.5–3 as compared to the traditional sequential solution method and the parallel block solver by a factor of 1.5 as compared to the traditional parallel sequential method. This block linear solver is, moreover, independent of discretization schemes and preconditioners used; thus further acceleration and higher accuracy can be expected when combined with other existing discretization schemes or preconditioners. - Highlights: • We solve the multiple-right-hand-side problem in DOT with a block BiCGStab method. • We examine the CPU times of the block solver and the traditional sequential solver. • The block solver is faster than the sequential solver by a factor of 1.5–3.0. • Multi-threading block solvers give additional speedup under limited threads situation.

  14. A vectorized Poisson solver over a spherical shell and its application to the quasi-geostrophic omega-equation

    Science.gov (United States)

    Mullenmeister, Paul

    1988-01-01

    The quasi-geostrophic omega-equation in flux form is developed as an example of a Poisson problem over a spherical shell. Solutions of this equation are obtained by applying a two-parameter Chebyshev solver in vector layout for CDC 200 series computers. The performance of this vectorized algorithm greatly exceeds the performance of its scalar analog. The algorithm generates solutions of the omega-equation which are compared with the omega fields calculated with the aid of the mass continuity equation.

  15. Solving very large scattering problems using a parallel PWTD-enhanced surface integral equation solver

    KAUST Repository

    Liu, Yang

    2013-07-01

    The computational complexity and memory requirements of multilevel plane wave time domain (PWTD)-accelerated marching-on-in-time (MOT)-based surface integral equation (SIE) solvers scale as O(NtNs(log 2)Ns) and O(Ns 1.5); here N t and Ns denote numbers of temporal and spatial basis functions discretizing the current [Shanker et al., IEEE Trans. Antennas Propag., 51, 628-641, 2003]. In the past, serial versions of these solvers have been successfully applied to the analysis of scattering from perfect electrically conducting as well as homogeneous penetrable targets involving up to Ns ≈ 0.5 × 106 and Nt ≈ 10 3. To solve larger problems, parallel PWTD-enhanced MOT solvers are called for. Even though a simple parallelization strategy was demonstrated in the context of electromagnetic compatibility analysis [M. Lu et al., in Proc. IEEE Int. Symp. AP-S, 4, 4212-4215, 2004], by and large, progress in this area has been slow. The lack of progress can be attributed wholesale to difficulties associated with the construction of a scalable PWTD kernel. © 2013 IEEE.

  16. A priori estimates and existence for a class of fully nonlinear elliptic equations in conformal geometry

    OpenAIRE

    Wang, Xu-Jia

    2006-01-01

    In this paper we prove the interior gradient and second derivative estimates for a class of fully nonlinear elliptic equations determined by symmetric functions of eigenvalues of the Ricci or Schouten tensors. As an application we prove the existence of solutions to the equations when the manifold is locally conformally flat or the Ricci curvature is positive.

  17. SMPBS: Web server for computing biomolecular electrostatics using finite element solvers of size modified Poisson-Boltzmann equation.

    Science.gov (United States)

    Xie, Yang; Ying, Jinyong; Xie, Dexuan

    2017-03-30

    SMPBS (Size Modified Poisson-Boltzmann Solvers) is a web server for computing biomolecular electrostatics using finite element solvers of the size modified Poisson-Boltzmann equation (SMPBE). SMPBE not only reflects ionic size effects but also includes the classic Poisson-Boltzmann equation (PBE) as a special case. Thus, its web server is expected to have a broader range of applications than a PBE web server. SMPBS is designed with a dynamic, mobile-friendly user interface, and features easily accessible help text, asynchronous data submission, and an interactive, hardware-accelerated molecular visualization viewer based on the 3Dmol.js library. In particular, the viewer allows computed electrostatics to be directly mapped onto an irregular triangular mesh of a molecular surface. Due to this functionality and the fast SMPBE finite element solvers, the web server is very efficient in the calculation and visualization of electrostatics. In addition, SMPBE is reconstructed using a new objective electrostatic free energy, clearly showing that the electrostatics and ionic concentrations predicted by SMPBE are optimal in the sense of minimizing the objective electrostatic free energy. SMPBS is available at the URL: smpbs.math.uwm.edu © 2017 Wiley Periodicals, Inc. © 2017 Wiley Periodicals, Inc.

  18. On Attainability of Optimal Solutions for Linear Elliptic Equations with Unbounded Coefficients

    Directory of Open Access Journals (Sweden)

    P. I. Kogut

    2011-12-01

    Full Text Available We study an optimal boundary control problem (OCP associated to a linear elliptic equation —div (Vj/ + A(xVy = f describing diffusion in a turbulent flow. The characteristic feature of this equation is the fact that, in applications, the stream matrix A(x = [a,ij(x]i,j=i,...,N is skew-symmetric, ац(х = —a,ji(x, measurable, and belongs to L -space (rather than L°°. An optimal solution to such problem can inherit a singular character of the original stream matrix A. We show that optimal solutions can be attainable by solutions of special optimal boundary control problems.

  19. A volume integral equation solver for quantum-corrected transient analysis of scattering from plasmonic nanostructures

    KAUST Repository

    Sayed, Sadeed Bin; Uysal, Ismail Enes; Bagci, Hakan; Ulku, H. Arda

    2018-01-01

    Quantum tunneling is observed between two nanostructures that are separated by a sub-nanometer gap. Electrons “jumping” from one structure to another create an additional current path. An auxiliary tunnel is introduced between the two structures as a support for this so that a classical electromagnetic solver can account for the effects of quantum tunneling. The dispersive permittivity of the tunnel is represented by a Drude model, whose parameters are obtained from the electron tunneling probability. The transient scattering from the connected nanostructures (i.e., nanostructures plus auxiliary tunnel) is analyzed using a time domain volume integral equation solver. Numerical results demonstrating the effect of quantum tunneling on the scattered fields are provided.

  20. Planar elliptic growth

    Energy Technology Data Exchange (ETDEWEB)

    Mineev, Mark [Los Alamos National Laboratory

    2008-01-01

    The planar elliptic extension of the Laplacian growth is, after a proper parametrization, given in a form of a solution to the equation for areapreserving diffeomorphisms. The infinite set of conservation laws associated with such elliptic growth is interpreted in terms of potential theory, and the relations between two major forms of the elliptic growth are analyzed. The constants of integration for closed form solutions are identified as the singularities of the Schwarz function, which are located both inside and outside the moving contour. Well-posedness of the recovery of the elliptic operator governing the process from the continuum of interfaces parametrized by time is addressed and two examples of exact solutions of elliptic growth are presented.

  1. Modeling of frequency-domain scalar wave equation with the average-derivative optimal scheme based on a multigrid-preconditioned iterative solver

    Science.gov (United States)

    Cao, Jian; Chen, Jing-Bo; Dai, Meng-Xue

    2018-01-01

    An efficient finite-difference frequency-domain modeling of seismic wave propagation relies on the discrete schemes and appropriate solving methods. The average-derivative optimal scheme for the scalar wave modeling is advantageous in terms of the storage saving for the system of linear equations and the flexibility for arbitrary directional sampling intervals. However, using a LU-decomposition-based direct solver to solve its resulting system of linear equations is very costly for both memory and computational requirements. To address this issue, we consider establishing a multigrid-preconditioned BI-CGSTAB iterative solver fit for the average-derivative optimal scheme. The choice of preconditioning matrix and its corresponding multigrid components is made with the help of Fourier spectral analysis and local mode analysis, respectively, which is important for the convergence. Furthermore, we find that for the computation with unequal directional sampling interval, the anisotropic smoothing in the multigrid precondition may affect the convergence rate of this iterative solver. Successful numerical applications of this iterative solver for the homogenous and heterogeneous models in 2D and 3D are presented where the significant reduction of computer memory and the improvement of computational efficiency are demonstrated by comparison with the direct solver. In the numerical experiments, we also show that the unequal directional sampling interval will weaken the advantage of this multigrid-preconditioned iterative solver in the computing speed or, even worse, could reduce its accuracy in some cases, which implies the need for a reasonable control of directional sampling interval in the discretization.

  2. Superposition of elliptic functions as solutions for a large number of nonlinear equations

    International Nuclear Information System (INIS)

    Khare, Avinash; Saxena, Avadh

    2014-01-01

    For a large number of nonlinear equations, both discrete and continuum, we demonstrate a kind of linear superposition. We show that whenever a nonlinear equation admits solutions in terms of both Jacobi elliptic functions cn(x, m) and dn(x, m) with modulus m, then it also admits solutions in terms of their sum as well as difference. We have checked this in the case of several nonlinear equations such as the nonlinear Schrödinger equation, MKdV, a mixed KdV-MKdV system, a mixed quadratic-cubic nonlinear Schrödinger equation, the Ablowitz-Ladik equation, the saturable nonlinear Schrödinger equation, λϕ 4 , the discrete MKdV as well as for several coupled field equations. Further, for a large number of nonlinear equations, we show that whenever a nonlinear equation admits a periodic solution in terms of dn 2 (x, m), it also admits solutions in terms of dn 2 (x,m)±√(m) cn (x,m) dn (x,m), even though cn(x, m)dn(x, m) is not a solution of these nonlinear equations. Finally, we also obtain superposed solutions of various forms for several coupled nonlinear equations

  3. Parallel, explicit, and PWTD-enhanced time domain volume integral equation solver

    KAUST Repository

    Liu, Yang

    2013-07-01

    Time domain volume integral equations (TDVIEs) are useful for analyzing transient scattering from inhomogeneous dielectric objects in applications as varied as photonics, optoelectronics, and bioelectromagnetics. TDVIEs typically are solved by implicit marching-on-in-time (MOT) schemes [N. T. Gres et al., Radio Sci., 36, 379-386, 2001], requiring the solution of a system of equations at each and every time step. To reduce the computational cost associated with such schemes, [A. Al-Jarro et al., IEEE Trans. Antennas Propagat., 60, 5203-5215, 2012] introduced an explicit MOT-TDVIE method that uses a predictor-corrector technique to stably update field values throughout the scatterer. By leveraging memory-efficient nodal spatial discretization and scalable parallelization schemes [A. Al-Jarro et al., in 28th Int. Rev. Progress Appl. Computat. Electromagn., 2012], this solver has been successfully applied to the analysis of scattering phenomena involving 0.5 million spatial unknowns. © 2013 IEEE.

  4. Modern solvers for Helmholtz problems

    CERN Document Server

    Tang, Jok; Vuik, Kees

    2017-01-01

    This edited volume offers a state of the art overview of fast and robust solvers for the Helmholtz equation. The book consists of three parts: new developments and analysis in Helmholtz solvers, practical methods and implementations of Helmholtz solvers, and industrial applications. The Helmholtz equation appears in a wide range of science and engineering disciplines in which wave propagation is modeled. Examples are: seismic inversion, ultrasone medical imaging, sonar detection of submarines, waves in harbours and many more. The partial differential equation looks simple but is hard to solve. In order to approximate the solution of the problem numerical methods are needed. First a discretization is done. Various methods can be used: (high order) Finite Difference Method, Finite Element Method, Discontinuous Galerkin Method and Boundary Element Method. The resulting linear system is large, where the size of the problem increases with increasing frequency. Due to higher frequencies the seismic images need to b...

  5. Existence and multiplicity of weak solutions for a class of degenerate nonlinear elliptic equations

    Directory of Open Access Journals (Sweden)

    Mihăilescu Mihai

    2006-01-01

    Full Text Available The goal of this paper is to study the existence and the multiplicity of non-trivial weak solutions for some degenerate nonlinear elliptic equations on the whole space . The solutions will be obtained in a subspace of the Sobolev space . The proofs rely essentially on the Mountain Pass theorem and on Ekeland's Variational principle.

  6. Second order degenerate elliptic equations

    International Nuclear Information System (INIS)

    Duong Minh Duc.

    1988-08-01

    Using an improved Sobolev inequality we study a class of elliptic operators which is degenerate inside the domain and strongly degenerate near the boundary of the domain. Our results are applicable to the L 2 -boundary value problem and the mixed boundary problem. (author). 18 refs

  7. SU-E-T-22: A Deterministic Solver of the Boltzmann-Fokker-Planck Equation for Dose Calculation

    Energy Technology Data Exchange (ETDEWEB)

    Hong, X; Gao, H [Shanghai Jiao Tong University, Shanghai, Shanghai (China); Paganetti, H [Massachusetts General Hospital, Boston, MA (United States)

    2015-06-15

    Purpose: The Boltzmann-Fokker-Planck equation (BFPE) accurately models the migration of photons/charged particles in tissues. While the Monte Carlo (MC) method is popular for solving BFPE in a statistical manner, we aim to develop a deterministic BFPE solver based on various state-of-art numerical acceleration techniques for rapid and accurate dose calculation. Methods: Our BFPE solver is based on the structured grid that is maximally parallelizable, with the discretization in energy, angle and space, and its cross section coefficients are derived or directly imported from the Geant4 database. The physical processes that are taken into account are Compton scattering, photoelectric effect, pair production for photons, and elastic scattering, ionization and bremsstrahlung for charged particles.While the spatial discretization is based on the diamond scheme, the angular discretization synergizes finite element method (FEM) and spherical harmonics (SH). Thus, SH is used to globally expand the scattering kernel and FFM is used to locally discretize the angular sphere. As a Result, this hybrid method (FEM-SH) is both accurate in dealing with forward-peaking scattering via FEM, and efficient for multi-energy-group computation via SH. In addition, FEM-SH enables the analytical integration in energy variable of delta scattering kernel for elastic scattering with reduced truncation error from the numerical integration based on the classic SH-based multi-energy-group method. Results: The accuracy of the proposed BFPE solver was benchmarked against Geant4 for photon dose calculation. In particular, FEM-SH had improved accuracy compared to FEM, while both were within 2% of the results obtained with Geant4. Conclusion: A deterministic solver of the Boltzmann-Fokker-Planck equation is developed for dose calculation, and benchmarked against Geant4. Xiang Hong and Hao Gao were partially supported by the NSFC (#11405105), the 973 Program (#2015CB856000) and the Shanghai Pujiang

  8. Lectures on Selected Topics in Mathematical Physics: Elliptic Functions and Elliptic Integrals

    Science.gov (United States)

    Schwalm, William A.

    2015-12-01

    This volume is a basic introduction to certain aspects of elliptic functions and elliptic integrals. Primarily, the elliptic functions stand out as closed solutions to a class of physical and geometrical problems giving rise to nonlinear differential equations. While these nonlinear equations may not be the types of greatest interest currently, the fact that they are solvable exactly in terms of functions about which much is known makes up for this. The elliptic functions of Jacobi, or equivalently the Weierstrass elliptic functions, inhabit the literature on current problems in condensed matter and statistical physics, on solitons and conformal representations, and all sorts of famous problems in classical mechanics. The lectures on elliptic functions have evolved as part of the first semester of a course on theoretical and mathematical methods given to first- and second-year graduate students in physics and chemistry at the University of North Dakota. They are for graduate students or for researchers who want an elementary introduction to the subject that nevertheless leaves them with enough of the details to address real problems. The style is supposed to be informal. The intention is to introduce the subject as a moderate extension of ordinary trigonometry in which the reference circle is replaced by an ellipse. This entre depends upon fewer tools and has seemed less intimidating that other typical introductions to the subject that depend on some knowledge of complex variables. The first three lectures assume only calculus, including the chain rule and elementary knowledge of differential equations. In the later lectures, the complex analytic properties are introduced naturally so that a more complete study becomes possible.

  9. Existence and multiplicity of weak solutions for a class of degenerate nonlinear elliptic equations

    Directory of Open Access Journals (Sweden)

    Mihai Mihăilescu

    2006-02-01

    Full Text Available The goal of this paper is to study the existence and the multiplicity of non-trivial weak solutions for some degenerate nonlinear elliptic equations on the whole space RN. The solutions will be obtained in a subspace of the Sobolev space W1/p(RN. The proofs rely essentially on the Mountain Pass theorem and on Ekeland's Variational principle.

  10. All-optical 1st- and 2nd-order differential equation solvers with large tuning ranges using Fabry-Pérot semiconductor optical amplifiers.

    Science.gov (United States)

    Chen, Kaisheng; Hou, Jie; Huang, Zhuyang; Cao, Tong; Zhang, Jihua; Yu, Yuan; Zhang, Xinliang

    2015-02-09

    We experimentally demonstrate an all-optical temporal computation scheme for solving 1st- and 2nd-order linear ordinary differential equations (ODEs) with tunable constant coefficients by using Fabry-Pérot semiconductor optical amplifiers (FP-SOAs). By changing the injection currents of FP-SOAs, the constant coefficients of the differential equations are practically tuned. A quite large constant coefficient tunable range from 0.0026/ps to 0.085/ps is achieved for the 1st-order differential equation. Moreover, the constant coefficient p of the 2nd-order ODE solver can be continuously tuned from 0.0216/ps to 0.158/ps, correspondingly with the constant coefficient q varying from 0.0000494/ps(2) to 0.006205/ps(2). Additionally, a theoretical model that combining the carrier density rate equation of the semiconductor optical amplifier (SOA) with the transfer function of the Fabry-Pérot (FP) cavity is exploited to analyze the solving processes. For both 1st- and 2nd-order solvers, excellent agreements between the numerical simulations and the experimental results are obtained. The FP-SOAs based all-optical differential-equation solvers can be easily integrated with other optical components based on InP/InGaAsP materials, such as laser, modulator, photodetector and waveguide, which can motivate the realization of the complicated optical computing on a single integrated chip.

  11. Anisotropic elliptic optical fibers

    Science.gov (United States)

    Kang, Soon Ahm

    1991-05-01

    The exact characteristic equation for an anisotropic elliptic optical fiber is obtained for odd and even hybrid modes in terms of infinite determinants utilizing Mathieu and modified Mathieu functions. A simplified characteristic equation is obtained by applying the weakly guiding approximation such that the difference in the refractive indices of the core and the cladding is small. The simplified characteristic equation is used to compute the normalized guide wavelength for an elliptical fiber. When the anisotropic parameter is equal to unity, the results are compared with the previous research and they are in close agreement. For a fixed value normalized cross-section area or major axis, the normalized guide wavelength lambda/lambda(sub 0) for an anisotropic elliptic fiber is small for the larger value of anisotropy. This condition indicates that more energy is carried inside of the fiber. However, the geometry and anisotropy of the fiber have a smaller effect when the normalized cross-section area is very small or very large.

  12. BOUNDARY VALUE PROBLEM FOR A LOADED EQUATION ELLIPTIC-HYPERBOLIC TYPE IN A DOUBLY CONNECTED DOMAIN

    Directory of Open Access Journals (Sweden)

    O.Kh. Abdullaev

    2014-06-01

    Full Text Available We study the existence and uniqueness of the solution of one boundary value problem for the loaded elliptic-hyperbolic equation of the second order with two lines of change of type in double-connected domain. Similar results have been received by D.M.Kuryhazov, when investigated domain is one-connected.

  13. Implementation of Generalized Adjoint Equation Solver for DeCART

    International Nuclear Information System (INIS)

    Han, Tae Young; Cho, Jin Young; Lee, Hyun Chul; Noh, Jae Man

    2013-01-01

    In this paper, the generalized adjoint solver based on the generalized perturbation theory is implemented on DeCART and the verification calculations were carried out. As the results, the adjoint flux for the general response coincides with the reference solution and it is expected that the solver could produce the parameters for the sensitivity and uncertainty analysis. Recently, MUSAD (Modules of Uncertainty and Sensitivity Analysis for DeCART) was developed for the uncertainty analysis of PMR200 core and the fundamental adjoint solver was implemented into DeCART. However, the application of the code was limited to the uncertainty to the multiplication factor, k eff , because it was based on the classical perturbation theory. For the uncertainty analysis to the general response as like the power density, it is necessary to develop the analysis module based on the generalized perturbation theory and it needs the generalized adjoint solutions from DeCART. In this paper, the generalized adjoint solver is implemented on DeCART and the calculation results are compared with the results by TSUNAMI of SCALE 6.1

  14. Two-dimensional steady unsaturated flow through embedded elliptical layers

    Science.gov (United States)

    Bakker, Mark; Nieber, John L.

    2004-12-01

    New analytic element solutions are presented for unsaturated, two-dimensional steady flow in vertical planes that include nonoverlapping impermeable elliptical layers and elliptical inhomogeneities. The hydraulic conductivity, which is represented by an exponential function of the pressure head, differs between the inside and outside of an elliptical inhomogeneity; both the saturated hydraulic conductivity and water retention parameters are allowed to differ between the inside and outside. The Richards equation is transformed, through the Kirchhoff transformation and a second standard transformation, into the modified Helmholtz equation. Analytic element solutions are obtained through separation of variables in elliptical coordinates. The resulting equations for the Kirchhoff potential consist of infinite sums of products of exponentials and modified Mathieu functions. In practical applications the series are truncated but still fulfill the differential equation exactly; boundary conditions are met approximately but up to machine accuracy, provided that enough terms are used. The pressure head, saturation, and flow may be computed analytically at any point in the vadose zone. Examples are given of the shadowing effect of an impermeable elliptical layer in a uniform flow field and funnel-type flow between two elliptical inhomogeneities. The presented solutions may be applied to study transport processes in vadose zones containing many impermeable elliptical layers or elliptical inhomogeneities.

  15. A boundary value approach for solving three-dimensional elliptic and hyperbolic partial differential equations.

    Science.gov (United States)

    Biala, T A; Jator, S N

    2015-01-01

    In this article, the boundary value method is applied to solve three dimensional elliptic and hyperbolic partial differential equations. The partial derivatives with respect to two of the spatial variables (y, z) are discretized using finite difference approximations to obtain a large system of ordinary differential equations (ODEs) in the third spatial variable (x). Using interpolation and collocation techniques, a continuous scheme is developed and used to obtain discrete methods which are applied via the Block unification approach to obtain approximations to the resulting large system of ODEs. Several test problems are investigated to elucidate the solution process.

  16. Workload Characterization of CFD Applications Using Partial Differential Equation Solvers

    Science.gov (United States)

    Waheed, Abdul; Yan, Jerry; Saini, Subhash (Technical Monitor)

    1998-01-01

    Workload characterization is used for modeling and evaluating of computing systems at different levels of detail. We present workload characterization for a class of Computational Fluid Dynamics (CFD) applications that solve Partial Differential Equations (PDEs). This workload characterization focuses on three high performance computing platforms: SGI Origin2000, EBM SP-2, a cluster of Intel Pentium Pro bases PCs. We execute extensive measurement-based experiments on these platforms to gather statistics of system resource usage, which results in workload characterization. Our workload characterization approach yields a coarse-grain resource utilization behavior that is being applied for performance modeling and evaluation of distributed high performance metacomputing systems. In addition, this study enhances our understanding of interactions between PDE solver workloads and high performance computing platforms and is useful for tuning these applications.

  17. Two-dimensional time dependent Riemann solvers for neutron transport

    International Nuclear Information System (INIS)

    Brunner, Thomas A.; Holloway, James Paul

    2005-01-01

    A two-dimensional Riemann solver is developed for the spherical harmonics approximation to the time dependent neutron transport equation. The eigenstructure of the resulting equations is explored, giving insight into both the spherical harmonics approximation and the Riemann solver. The classic Roe-type Riemann solver used here was developed for one-dimensional problems, but can be used in multidimensional problems by treating each face of a two-dimensional computation cell in a locally one-dimensional way. Several test problems are used to explore the capabilities of both the Riemann solver and the spherical harmonics approximation. The numerical solution for a simple line source problem is compared to the analytic solution to both the P 1 equation and the full transport solution. A lattice problem is used to test the method on a more challenging problem

  18. Parallel linear solvers for simulations of reactor thermal hydraulics

    International Nuclear Information System (INIS)

    Yan, Y.; Antal, S.P.; Edge, B.; Keyes, D.E.; Shaver, D.; Bolotnov, I.A.; Podowski, M.Z.

    2011-01-01

    The state-of-the-art multiphase fluid dynamics code, NPHASE-CMFD, performs multiphase flow simulations in complex domains using implicit nonlinear treatment of the governing equations and in parallel, which is a very challenging environment for the linear solver. The present work illustrates how the Portable, Extensible Toolkit for Scientific Computation (PETSc) and scalable Algebraic Multigrid (AMG) preconditioner from Hypre can be utilized to construct robust and scalable linear solvers for the Newton correction equation obtained from the discretized system of governing conservation equations in NPHASE-CMFD. The overall long-tem objective of this work is to extend the NPHASE-CMFD code into a fully-scalable solver of multiphase flow and heat transfer problems, applicable to both steady-state and stiff time-dependent phenomena in complete fuel assemblies of nuclear reactors and, eventually, the entire reactor core (such as the Virtual Reactor concept envisioned by CASL). This campaign appropriately begins with the linear algebraic equation solver, which is traditionally a bottleneck to scalability in PDE-based codes. The computational complexity of the solver is usually superlinear in problem size, whereas the rest of the code, the “physics” portion, usually has its complexity linear in the problem size. (author)

  19. Partial differential operators of elliptic type

    CERN Document Server

    Shimakura, Norio

    1992-01-01

    This book, which originally appeared in Japanese, was written for use in an undergraduate course or first year graduate course in partial differential equations and is likely to be of interest to researchers as well. This book presents a comprehensive study of the theory of elliptic partial differential operators. Beginning with the definitions of ellipticity for higher order operators, Shimakura discusses the Laplacian in Euclidean spaces, elementary solutions, smoothness of solutions, Vishik-Sobolev problems, the Schauder theory, and degenerate elliptic operators. The appendix covers such preliminaries as ordinary differential equations, Sobolev spaces, and maximum principles. Because elliptic operators arise in many areas, readers will appreciate this book for the way it brings together a variety of techniques that have arisen in different branches of mathematics.

  20. Existence and concentration of positive solutions for a quasilinear elliptic equation in R

    Directory of Open Access Journals (Sweden)

    Elisandra Gloss

    2010-05-01

    Full Text Available We study the existence and concentration of positive solutions for the quasilinear elliptic equation $$ -varepsilon^2u'' -varepsilon^2(u^2''u+V(x u = h(u $$ in $mathbb{R}$ as $varepsilono 0$, where the potential $V:mathbb{R}o mathbb{R}$ has a positive infimum and $inf_{partial Omega}V>inf_{ Omega}V$ for some bounded domain $Omega$ in $mathbb{R}$, and $h$ is a nonlinearity without having growth conditions such as Ambrosetti-Rabinowitz.

  1. A Fokker-Planck-Landau collision equation solver on two-dimensional velocity grid and its application to particle-in-cell simulation

    Energy Technology Data Exchange (ETDEWEB)

    Yoon, E. S.; Chang, C. S., E-mail: cschang@pppl.gov [Princeton Plasma Physics Laboratory, Princeton University, Princeton, New Jersey 08543 (United States); Korea Advanced Institute of Science and Technology, Yuseong-gu, DaeJeon 305-701 (Korea, Republic of)

    2014-03-15

    An approximate two-dimensional solver of the nonlinear Fokker-Planck-Landau collision operator has been developed using the assumption that the particle probability distribution function is independent of gyroangle in the limit of strong magnetic field. The isotropic one-dimensional scheme developed for nonlinear Fokker-Planck-Landau equation by Buet and Cordier [J. Comput. Phys. 179, 43 (2002)] and for linear Fokker-Planck-Landau equation by Chang and Cooper [J. Comput. Phys. 6, 1 (1970)] have been modified and extended to two-dimensional nonlinear equation. In addition, a method is suggested to apply the new velocity-grid based collision solver to Lagrangian particle-in-cell simulation by adjusting the weights of marker particles and is applied to a five dimensional particle-in-cell code to calculate the neoclassical ion thermal conductivity in a tokamak plasma. Error verifications show practical aspects of the present scheme for both grid-based and particle-based kinetic codes.

  2. Effective Elliptic Models for Efficient Wavefield Extrapolation in Anisotropic Media

    KAUST Repository

    Waheed, Umair bin

    2014-05-01

    Wavefield extrapolation operator for elliptically anisotropic media offers significant cost reduction compared to that of transversely isotropic media (TI), especially when the medium exhibits tilt in the symmetry axis (TTI). However, elliptical anisotropy does not provide accurate focusing for TI media. Therefore, we develop effective elliptically anisotropic models that correctly capture the kinematic behavior of the TTI wavefield. Specifically, we use an iterative elliptically anisotropic eikonal solver that provides the accurate traveltimes for a TI model. The resultant coefficients of the elliptical eikonal provide the effective models. These effective models allow us to use the cheaper wavefield extrapolation operator for elliptic media to obtain approximate wavefield solutions for TTI media. Despite the fact that the effective elliptic models are obtained by kinematic matching using high-frequency asymptotic, the resulting wavefield contains most of the critical wavefield components, including the frequency dependency and caustics, if present, with reasonable accuracy. The methodology developed here offers a much better cost versus accuracy tradeoff for wavefield computations in TTI media, considering the cost prohibitive nature of the problem. We demonstrate the applicability of the proposed approach on the BP TTI model.

  3. Effective Elliptic Models for Efficient Wavefield Extrapolation in Anisotropic Media

    KAUST Repository

    Waheed, Umair bin; Alkhalifah, Tariq Ali

    2014-01-01

    Wavefield extrapolation operator for elliptically anisotropic media offers significant cost reduction compared to that of transversely isotropic media (TI), especially when the medium exhibits tilt in the symmetry axis (TTI). However, elliptical anisotropy does not provide accurate focusing for TI media. Therefore, we develop effective elliptically anisotropic models that correctly capture the kinematic behavior of the TTI wavefield. Specifically, we use an iterative elliptically anisotropic eikonal solver that provides the accurate traveltimes for a TI model. The resultant coefficients of the elliptical eikonal provide the effective models. These effective models allow us to use the cheaper wavefield extrapolation operator for elliptic media to obtain approximate wavefield solutions for TTI media. Despite the fact that the effective elliptic models are obtained by kinematic matching using high-frequency asymptotic, the resulting wavefield contains most of the critical wavefield components, including the frequency dependency and caustics, if present, with reasonable accuracy. The methodology developed here offers a much better cost versus accuracy tradeoff for wavefield computations in TTI media, considering the cost prohibitive nature of the problem. We demonstrate the applicability of the proposed approach on the BP TTI model.

  4. Dynamical R Matrices of Elliptic Quantum Groups and Connection Matrices for the q-KZ Equations

    Directory of Open Access Journals (Sweden)

    Hitoshi Konno

    2006-12-01

    Full Text Available For any affine Lie algebra ${mathfrak g}$, we show that any finite dimensional representation of the universal dynamical $R$ matrix ${cal R}(lambda$ of the elliptic quantum group ${cal B}_{q,lambda}({mathfrak g}$ coincides with a corresponding connection matrix for the solutions of the $q$-KZ equation associated with $U_q({mathfrak g}$. This provides a general connection between ${cal B}_{q,lambda}({mathfrak g}$ and the elliptic face (IRF or SOS models. In particular, we construct vector representations of ${cal R}(lambda$ for ${mathfrak g}=A_n^{(1}$, $B_n^{(1}$, $C_n^{(1}$, $D_n^{(1}$, and show that they coincide with the face weights derived by Jimbo, Miwa and Okado. We hence confirm the conjecture by Frenkel and Reshetikhin.

  5. A prediction model of compressor with variable-geometry diffuser based on elliptic equation and partial least squares.

    Science.gov (United States)

    Li, Xu; Yang, Chuanlei; Wang, Yinyan; Wang, Hechun

    2018-01-01

    To achieve a much more extensive intake air flow range of the diesel engine, a variable-geometry compressor (VGC) is introduced into a turbocharged diesel engine. However, due to the variable diffuser vane angle (DVA), the prediction for the performance of the VGC becomes more difficult than for a normal compressor. In the present study, a prediction model comprising an elliptical equation and a PLS (partial least-squares) model was proposed to predict the performance of the VGC. The speed lines of the pressure ratio map and the efficiency map were fitted with the elliptical equation, and the coefficients of the elliptical equation were introduced into the PLS model to build the polynomial relationship between the coefficients and the relative speed, the DVA. Further, the maximal order of the polynomial was investigated in detail to reduce the number of sub-coefficients and achieve acceptable fit accuracy simultaneously. The prediction model was validated with sample data and in order to present the superiority of compressor performance prediction, the prediction results of this model were compared with those of the look-up table and back-propagation neural networks (BPNNs). The validation and comparison results show that the prediction accuracy of the new developed model is acceptable, and this model is much more suitable than the look-up table and the BPNN methods under the same condition in VGC performance prediction. Moreover, the new developed prediction model provides a novel and effective prediction solution for the VGC and can be used to improve the accuracy of the thermodynamic model for turbocharged diesel engines in the future.

  6. Second-Order Necessary Optimality Conditions for Some State-Constrained Control Problems of Semilinear Elliptic Equations

    International Nuclear Information System (INIS)

    Casas, E.; Troeltzsch, F.

    1999-01-01

    In this paper we are concerned with some optimal control problems governed by semilinear elliptic equations. The case of a boundary control is studied. We consider pointwise constraints on the control and a finite number of equality and inequality constraints on the state. The goal is to derive first- and second-order optimality conditions satisfied by locally optimal solutions of the problem

  7. Description and use of LSODE, the Livermore Solver for Ordinary Differential Equations

    Science.gov (United States)

    Radhakrishnan, Krishnan; Hindmarsh, Alan C.

    1993-01-01

    LSODE, the Livermore Solver for Ordinary Differential Equations, is a package of FORTRAN subroutines designed for the numerical solution of the initial value problem for a system of ordinary differential equations. It is particularly well suited for 'stiff' differential systems, for which the backward differentiation formula method of orders 1 to 5 is provided. The code includes the Adams-Moulton method of orders 1 to 12, so it can be used for nonstiff problems as well. In addition, the user can easily switch methods to increase computational efficiency for problems that change character. For both methods a variety of corrector iteration techniques is included in the code. Also, to minimize computational work, both the step size and method order are varied dynamically. This report presents complete descriptions of the code and integration methods, including their implementation. It also provides a detailed guide to the use of the code, as well as an illustrative example problem.

  8. Iterative Observer-based Estimation Algorithms for Steady-State Elliptic Partial Differential Equation Systems

    KAUST Repository

    Majeed, Muhammad Usman

    2017-07-19

    Steady-state elliptic partial differential equations (PDEs) are frequently used to model a diverse range of physical phenomena. The source and boundary data estimation problems for such PDE systems are of prime interest in various engineering disciplines including biomedical engineering, mechanics of materials and earth sciences. Almost all existing solution strategies for such problems can be broadly classified as optimization-based techniques, which are computationally heavy especially when the problems are formulated on higher dimensional space domains. However, in this dissertation, feedback based state estimation algorithms, known as state observers, are developed to solve such steady-state problems using one of the space variables as time-like. In this regard, first, an iterative observer algorithm is developed that sweeps over regular-shaped domains and solves boundary estimation problems for steady-state Laplace equation. It is well-known that source and boundary estimation problems for the elliptic PDEs are highly sensitive to noise in the data. For this, an optimal iterative observer algorithm, which is a robust counterpart of the iterative observer, is presented to tackle the ill-posedness due to noise. The iterative observer algorithm and the optimal iterative algorithm are then used to solve source localization and estimation problems for Poisson equation for noise-free and noisy data cases respectively. Next, a divide and conquer approach is developed for three-dimensional domains with two congruent parallel surfaces to solve the boundary and the source data estimation problems for the steady-state Laplace and Poisson kind of systems respectively. Theoretical results are shown using a functional analysis framework, and consistent numerical simulation results are presented for several test cases using finite difference discretization schemes.

  9. Vertical elliptic operator for efficient wave propagation in TTI media

    KAUST Repository

    Waheed, Umair bin; Alkhalifah, Tariq Ali

    2015-01-01

    Elliptic wave extrapolation operators require significantly less computational cost than the ones for transversely isotropic (TI) media. However, it does not provide accurate wavefield representation or imaging for the prevalent TI media. We propose a new vertical elliptically anisotropic (VEA) wave equation by decomposing the acoustic TI pseudo-differential wave equation. The decomposition results in a vertical elliptic differential equation and a scalar operator. The new VEA-like wave equation shares the same dispersion relation as that of the original acoustic TI wave equation. Therefore, the kinematic contents are correctly matched to the original equation. Moreover, the proposed decomposition yields better amplitude properties than the isotropic decomposition without increasing the computational load. Therefore, it exhibits better cost versus accuracy tradeoff compared to the isotropic or the tilted elliptic decompositions. We demonstrate with numerical examples that the proposed methodology is numerically stable for complex models and is free from shear-wave artifacts.

  10. Vertical elliptic operator for efficient wave propagation in TTI media

    KAUST Repository

    Waheed, Umair bin

    2015-08-19

    Elliptic wave extrapolation operators require significantly less computational cost than the ones for transversely isotropic (TI) media. However, it does not provide accurate wavefield representation or imaging for the prevalent TI media. We propose a new vertical elliptically anisotropic (VEA) wave equation by decomposing the acoustic TI pseudo-differential wave equation. The decomposition results in a vertical elliptic differential equation and a scalar operator. The new VEA-like wave equation shares the same dispersion relation as that of the original acoustic TI wave equation. Therefore, the kinematic contents are correctly matched to the original equation. Moreover, the proposed decomposition yields better amplitude properties than the isotropic decomposition without increasing the computational load. Therefore, it exhibits better cost versus accuracy tradeoff compared to the isotropic or the tilted elliptic decompositions. We demonstrate with numerical examples that the proposed methodology is numerically stable for complex models and is free from shear-wave artifacts.

  11. Approximate rational Jacobi elliptic function solutions of the fractional differential equations via the enhanced Adomian decomposition method

    International Nuclear Information System (INIS)

    Song Lina; Wang Weiguo

    2010-01-01

    In this Letter, an enhanced Adomian decomposition method which introduces the h-curve of the homotopy analysis method into the standard Adomian decomposition method is proposed. Some examples prove that this method can derive successfully approximate rational Jacobi elliptic function solutions of the fractional differential equations.

  12. Multi-GPU-based acceleration of the explicit time domain volume integral equation solver using MPI-OpenACC

    KAUST Repository

    Feki, Saber

    2013-07-01

    An explicit marching-on-in-time (MOT)-based time-domain volume integral equation (TDVIE) solver has recently been developed for characterizing transient electromagnetic wave interactions on arbitrarily shaped dielectric bodies (A. Al-Jarro et al., IEEE Trans. Antennas Propag., vol. 60, no. 11, 2012). The solver discretizes the spatio-temporal convolutions of the source fields with the background medium\\'s Green function using nodal discretization in space and linear interpolation in time. The Green tensor, which involves second order spatial and temporal derivatives, is computed using finite differences on the temporal and spatial grid. A predictor-corrector algorithm is used to maintain the stability of the MOT scheme. The simplicity of the discretization scheme permits the computation of the discretized spatio-temporal convolutions on the fly during time marching; no \\'interaction\\' matrices are pre-computed or stored resulting in a memory efficient scheme. As a result, most often the applicability of this solver to the characterization of wave interactions on electrically large structures is limited by the computation time but not the memory. © 2013 IEEE.

  13. Overdetermined elliptic problems in topological disks

    Science.gov (United States)

    Mira, Pablo

    2018-06-01

    We introduce a method, based on the Poincaré-Hopf index theorem, to classify solutions to overdetermined problems for fully nonlinear elliptic equations in domains diffeomorphic to a closed disk. Applications to some well-known nonlinear elliptic PDEs are provided. Our result can be seen as the analogue of Hopf's uniqueness theorem for constant mean curvature spheres, but for the general analytic context of overdetermined elliptic problems.

  14. Test set for initial value problem solvers

    NARCIS (Netherlands)

    W.M. Lioen (Walter); J.J.B. de Swart (Jacques)

    1998-01-01

    textabstractThe CWI test set for IVP solvers presents a collection of Initial Value Problems to test solvers for implicit differential equations. This test set can both decrease the effort for the code developer to test his software in a reliable way, and cross the bridge between the application

  15. Modified quasi-boundary value method for Cauchy problems of elliptic equations with variable coefficients

    Directory of Open Access Journals (Sweden)

    Hongwu Zhang

    2011-08-01

    Full Text Available In this article, we study a Cauchy problem for an elliptic equation with variable coefficients. It is well-known that such a problem is severely ill-posed; i.e., the solution does not depend continuously on the Cauchy data. We propose a modified quasi-boundary value regularization method to solve it. Convergence estimates are established under two a priori assumptions on the exact solution. A numerical example is given to illustrate our proposed method.

  16. A non-conforming 3D spherical harmonic transport solver

    Energy Technology Data Exchange (ETDEWEB)

    Van Criekingen, S. [Commissariat a l' Energie Atomique CEA-Saclay, DEN/DM2S/SERMA/LENR Bat 470, 91191 Gif-sur-Yvette, Cedex (France)

    2006-07-01

    A new 3D transport solver for the time-independent Boltzmann transport equation has been developed. This solver is based on the second-order even-parity form of the transport equation. The angular discretization is performed through the expansion of the angular neutron flux in spherical harmonics (PN method). The novelty of this solver is the use of non-conforming finite elements for the spatial discretization. Such elements lead to a discontinuous flux approximation. This interface continuity requirement relaxation property is shared with mixed-dual formulations such as the ones based on Raviart-Thomas finite elements. Encouraging numerical results are presented. (authors)

  17. A non-conforming 3D spherical harmonic transport solver

    International Nuclear Information System (INIS)

    Van Criekingen, S.

    2006-01-01

    A new 3D transport solver for the time-independent Boltzmann transport equation has been developed. This solver is based on the second-order even-parity form of the transport equation. The angular discretization is performed through the expansion of the angular neutron flux in spherical harmonics (PN method). The novelty of this solver is the use of non-conforming finite elements for the spatial discretization. Such elements lead to a discontinuous flux approximation. This interface continuity requirement relaxation property is shared with mixed-dual formulations such as the ones based on Raviart-Thomas finite elements. Encouraging numerical results are presented. (authors)

  18. A fast Cauchy-Riemann solver. [differential equation solution for boundary conditions by finite difference approximation

    Science.gov (United States)

    Ghil, M.; Balgovind, R.

    1979-01-01

    The inhomogeneous Cauchy-Riemann equations in a rectangle are discretized by a finite difference approximation. Several different boundary conditions are treated explicitly, leading to algorithms which have overall second-order accuracy. All boundary conditions with either u or v prescribed along a side of the rectangle can be treated by similar methods. The algorithms presented here have nearly minimal time and storage requirements and seem suitable for development into a general-purpose direct Cauchy-Riemann solver for arbitrary boundary conditions.

  19. Asymptotic expansions for high-contrast elliptic equations

    KAUST Repository

    Calo, Victor M.; Efendiev, Yalchin R.; Galvis, Juan

    2014-01-01

    In this paper, we present a high-order expansion for elliptic equations in high-contrast media. The background conductivity is taken to be one and we assume the medium contains high (or low) conductivity inclusions. We derive an asymptotic expansion with respect to the contrast and provide a procedure to compute the terms in the expansion. The computation of the expansion does not depend on the contrast which is important for simulations. The latter allows avoiding increased mesh resolution around high conductivity features. This work is partly motivated by our earlier work in [Domain decomposition preconditioners for multiscale flows in high-contrast media, Multiscale Model Simul. 8 (2010) 1461-1483] where we design efficient numerical procedures for solving high-contrast problems. These multiscale approaches require local solutions and our proposed high-order expansion can be used to approximate these local solutions inexpensively. In the case of a large-number of inclusions, the proposed analysis can help to design localization techniques for computing the terms in the expansion. In the paper, we present a rigorous analysis of the proposed high-order expansion and estimate the remainder of it. We consider both high-and low-conductivity inclusions. © 2014 World Scientific Publishing Company.

  20. Asymptotic expansions for high-contrast elliptic equations

    KAUST Repository

    Calo, Victor M.

    2014-03-01

    In this paper, we present a high-order expansion for elliptic equations in high-contrast media. The background conductivity is taken to be one and we assume the medium contains high (or low) conductivity inclusions. We derive an asymptotic expansion with respect to the contrast and provide a procedure to compute the terms in the expansion. The computation of the expansion does not depend on the contrast which is important for simulations. The latter allows avoiding increased mesh resolution around high conductivity features. This work is partly motivated by our earlier work in [Domain decomposition preconditioners for multiscale flows in high-contrast media, Multiscale Model Simul. 8 (2010) 1461-1483] where we design efficient numerical procedures for solving high-contrast problems. These multiscale approaches require local solutions and our proposed high-order expansion can be used to approximate these local solutions inexpensively. In the case of a large-number of inclusions, the proposed analysis can help to design localization techniques for computing the terms in the expansion. In the paper, we present a rigorous analysis of the proposed high-order expansion and estimate the remainder of it. We consider both high-and low-conductivity inclusions. © 2014 World Scientific Publishing Company.

  1. Fast Multipole-Based Preconditioner for Sparse Iterative Solvers

    KAUST Repository

    Ibeid, Huda; Yokota, Rio; Keyes, David E.

    2014-01-01

    Among optimal hierarchical algorithms for the computational solution of elliptic problems, the Fast Multipole Method (FMM) stands out for its adaptability to emerging architectures, having high arithmetic intensity, tunable accuracy, and relaxed global synchronization requirements. We demonstrate that, beyond its traditional use as a solver in problems for which explicit free-space kernel representations are available, the FMM has applicability as a preconditioner in finite domain elliptic boundary value problems, by equipping it with boundary integral capability for finite boundaries and by wrapping it in a Krylov method for extensibility to more general operators. Compared with multilevel methods, it is capable of comparable algebraic convergence rates down to the truncation error of the discretized PDE, and it has superior multicore and distributed memory scalability properties on commodity architecture supercomputers.

  2. Fast Multipole-Based Preconditioner for Sparse Iterative Solvers

    KAUST Repository

    Ibeid, Huda

    2014-05-04

    Among optimal hierarchical algorithms for the computational solution of elliptic problems, the Fast Multipole Method (FMM) stands out for its adaptability to emerging architectures, having high arithmetic intensity, tunable accuracy, and relaxed global synchronization requirements. We demonstrate that, beyond its traditional use as a solver in problems for which explicit free-space kernel representations are available, the FMM has applicability as a preconditioner in finite domain elliptic boundary value problems, by equipping it with boundary integral capability for finite boundaries and by wrapping it in a Krylov method for extensibility to more general operators. Compared with multilevel methods, it is capable of comparable algebraic convergence rates down to the truncation error of the discretized PDE, and it has superior multicore and distributed memory scalability properties on commodity architecture supercomputers.

  3. Short-Term Comparison of Several Solutinos of Elliptic Relative Motion

    Directory of Open Access Journals (Sweden)

    Jung Hyun Jo

    2007-12-01

    Full Text Available Recently introduced, several explicit solutions of relative motion between neighboring elliptic satellite orbits are reviewed. The performance of these solutions is compared with an analytic solution of the general linearized equation of motion. The inversion solution by the Hill-Clohessy-Wiltshire equations is used to produce the initial condition of numerical results. Despite the difference of the reference orbit, the relative motion with the relatively small eccentricity shows the similar results on elliptic case and circular case. In case of the 'chief' satellite with the relatively large eccentricity, HCW equation with the circular reference orbit has relatively larger error than other elliptic equation of motion does.

  4. The Dirichlet problem with L2-boundary data for elliptic linear equations

    CERN Document Server

    Chabrowski, Jan

    1991-01-01

    The Dirichlet problem has a very long history in mathematics and its importance in partial differential equations, harmonic analysis, potential theory and the applied sciences is well-known. In the last decade the Dirichlet problem with L2-boundary data has attracted the attention of several mathematicians. The significant features of this recent research are the use of weighted Sobolev spaces, existence results for elliptic equations under very weak regularity assumptions on coefficients, energy estimates involving L2-norm of a boundary data and the construction of a space larger than the usual Sobolev space W1,2 such that every L2-function on the boundary of a given set is the trace of a suitable element of this space. The book gives a concise account of main aspects of these recent developments and is intended for researchers and graduate students. Some basic knowledge of Sobolev spaces and measure theory is required.

  5. Elliptic Determinantal Processes and Elliptic Dyson Models

    Science.gov (United States)

    Katori, Makoto

    2017-10-01

    We introduce seven families of stochastic systems of interacting particles in one-dimension corresponding to the seven families of irreducible reduced affine root systems. We prove that they are determinantal in the sense that all spatio-temporal correlation functions are given by determinants controlled by a single function called the spatio-temporal correlation kernel. For the four families {A}_{N-1}, {B}_N, {C}_N and {D}_N, we identify the systems of stochastic differential equations solved by these determinantal processes, which will be regarded as the elliptic extensions of the Dyson model. Here we use the notion of martingales in probability theory and the elliptic determinant evaluations of the Macdonald denominators of irreducible reduced affine root systems given by Rosengren and Schlosser.

  6. Existence of solutions of the Dirichlet problem for an infinite system of nonlinear differential-functional equations of elliptic type

    Directory of Open Access Journals (Sweden)

    Tomasz S. Zabawa

    2005-01-01

    Full Text Available The Dirichlet problem for an infinite weakly coupled system of semilinear differential-functional equations of elliptic type is considered. It is shown the existence of solutions to this problem. The result is based on Chaplygin's method of lower and upper functions.

  7. Drifting solutions with elliptic symmetry for the compressible Navier-Stokes equations with density-dependent viscosity

    International Nuclear Information System (INIS)

    An, Hongli; Yuen, Manwai

    2014-01-01

    In this paper, we investigate the analytical solutions of the compressible Navier-Stokes equations with dependent-density viscosity. By using the characteristic method, we successfully obtain a class of drifting solutions with elliptic symmetry for the Navier-Stokes model wherein the velocity components are governed by a generalized Emden dynamical system. In particular, when the viscosity variables are taken the same as Yuen [M. W. Yuen, “Analytical solutions to the Navier-Stokes equations,” J. Math. Phys. 49, 113102 (2008)], our solutions constitute a generalization of that obtained by Yuen. Interestingly, numerical simulations show that the analytical solutions can be used to explain the drifting phenomena of the propagation wave like Tsunamis in oceans

  8. T2CG1, a package of preconditioned conjugate gradient solvers for TOUGH2

    International Nuclear Information System (INIS)

    Moridis, G.; Pruess, K.; Antunez, E.

    1994-03-01

    Most of the computational work in the numerical simulation of fluid and heat flows in permeable media arises in the solution of large systems of linear equations. The simplest technique for solving such equations is by direct methods. However, because of large storage requirements and accumulation of roundoff errors, the application of direct solution techniques is limited, depending on matrix bandwidth, to systems of a few hundred to at most a few thousand simultaneous equations. T2CG1, a package of preconditioned conjugate gradient solvers, has been added to TOUGH2 to complement its direct solver and significantly increase the size of problems tractable on PCs. T2CG1 includes three different solvers: a Bi-Conjugate Gradient (BCG) solver, a Bi-Conjugate Gradient Squared (BCGS) solver, and a Generalized Minimum Residual (GMRES) solver. Results from six test problems with up to 30,000 equations show that T2CG1 (1) is significantly (and invariably) faster and requires far less memory than the MA28 direct solver, (2) it makes possible the solution of very large three-dimensional problems on PCs, and (3) that the BCGS solver is the fastest of the three in the tested problems. Sample problems are presented related to heat and fluid flow at Yucca Mountain and WIPP, environmental remediation by the Thermal Enhanced Vapor Extraction System, and geothermal resources

  9. Implementation of geomechanical models for engineered clay barriers in multi-physic partial differential equation solvers

    International Nuclear Information System (INIS)

    Navarro, V.; Alonso, J.; Asensio, L.; Yustres, A.; Pintado, X.

    2012-01-01

    Document available in extended abstract form only. The use of numerical methods, especially the Finite Element Method (FEM), for solving boundary problems in Unsaturated Soil Mechanics has experienced significant progress. Several codes, both built mainly for research purposes and commercial software, are now available. In the last years, Multi-physic Partial Differentiation Equation Solvers (MPDES) have turned out to be an interesting proposal. In this family of solvers, the user defines the governing equations and the behaviour models, generally using a computer algebra environment. The code automatically assembles and solves the equation systems, saving the user having to redefine the structures of memory storage or to implement solver algorithms. The user can focus on the definition of the physics of the problem, while it is possible to couple virtually any physical or chemical process that can be described by a PDE. This can be done, for instance, in COMSOL Multiphysics (CM). Nonetheless, the versatility of CM is compromised by the impossibility to implement models with variables defined by implicit functions. Elasto-plastic models involve an implicit coupling among stress increments, plastic strains and plastic variables increments. For this reason, they cannot be implemented in CM in a straightforward way. This means a very relevant limitation for the use of this tool in the analysis of geomechanical boundary value problems. In this work, a strategy to overcome this problem using the multi-physics concept is presented. A mixed method is proposed, considering the constitutive stresses, the pre-consolidation pressure and the plastic variables as main unknowns of the model. Mixed methods usually present stability problems. However, the algorithmics present in CM include several numerical strategies to minimise this kind of problems. Besides, CM is based on the application of the FEM with Lagrange multipliers, an approach that significantly contributes stability

  10. Analysis of transient plasmonic interactions using an MOT-PMCHWT integral equation solver

    KAUST Repository

    Uysal, Ismail Enes; Ulku, Huseyin Arda; Bagci, Hakan

    2014-01-01

    that discretize only on the interfaces. Additionally, IE solvers implicitly enforce the radiation condition and consequently do not need (approximate) absorbing boundary conditions. Despite these advantages, IE solvers, especially in time domain, have not been

  11. A model and variance reduction method for computing statistical outputs of stochastic elliptic partial differential equations

    International Nuclear Information System (INIS)

    Vidal-Codina, F.; Nguyen, N.C.; Giles, M.B.; Peraire, J.

    2015-01-01

    We present a model and variance reduction method for the fast and reliable computation of statistical outputs of stochastic elliptic partial differential equations. Our method consists of three main ingredients: (1) the hybridizable discontinuous Galerkin (HDG) discretization of elliptic partial differential equations (PDEs), which allows us to obtain high-order accurate solutions of the governing PDE; (2) the reduced basis method for a new HDG discretization of the underlying PDE to enable real-time solution of the parameterized PDE in the presence of stochastic parameters; and (3) a multilevel variance reduction method that exploits the statistical correlation among the different reduced basis approximations and the high-fidelity HDG discretization to accelerate the convergence of the Monte Carlo simulations. The multilevel variance reduction method provides efficient computation of the statistical outputs by shifting most of the computational burden from the high-fidelity HDG approximation to the reduced basis approximations. Furthermore, we develop a posteriori error estimates for our approximations of the statistical outputs. Based on these error estimates, we propose an algorithm for optimally choosing both the dimensions of the reduced basis approximations and the sizes of Monte Carlo samples to achieve a given error tolerance. We provide numerical examples to demonstrate the performance of the proposed method

  12. Parallel time domain solvers for electrically large transient scattering problems

    KAUST Repository

    Liu, Yang

    2014-09-26

    Marching on in time (MOT)-based integral equation solvers represent an increasingly appealing avenue for analyzing transient electromagnetic interactions with large and complex structures. MOT integral equation solvers for analyzing electromagnetic scattering from perfect electrically conducting objects are obtained by enforcing electric field boundary conditions and implicitly time advance electric surface current densities by iteratively solving sparse systems of equations at all time steps. Contrary to finite difference and element competitors, these solvers apply to nonlinear and multi-scale structures comprising geometrically intricate and deep sub-wavelength features residing atop electrically large platforms. Moreover, they are high-order accurate, stable in the low- and high-frequency limits, and applicable to conducting and penetrable structures represented by highly irregular meshes. This presentation reviews some recent advances in the parallel implementations of time domain integral equation solvers, specifically those that leverage multilevel plane-wave time-domain algorithm (PWTD) on modern manycore computer architectures including graphics processing units (GPUs) and distributed memory supercomputers. The GPU-based implementation achieves at least one order of magnitude speedups compared to serial implementations while the distributed parallel implementation are highly scalable to thousands of compute-nodes. A distributed parallel PWTD kernel has been adopted to solve time domain surface/volume integral equations (TDSIE/TDVIE) for analyzing transient scattering from large and complex-shaped perfectly electrically conducting (PEC)/dielectric objects involving ten million/tens of millions of spatial unknowns.

  13. An Analysis of Elliptic Grid Generation Techniques Using an Implicit Euler Solver.

    Science.gov (United States)

    1986-06-09

    at M. =0.90 and a=00 is when interpolating for the radius of curvature obtained. One expects the computed shock strength (r), a second examination is...solver to yield accurate second-order, ... v.s zd solutions. References Snn, .:-P.. Flr.e ’rference Methods In Z, .tational Fluid DinamIcs , to he published

  14. Fast sweeping algorithm for accurate solution of the TTI eikonal equation using factorization

    KAUST Repository

    bin Waheed, Umair

    2017-06-10

    Traveltime computation is essential for many seismic data processing applications and velocity analysis tools. High-resolution seismic imaging requires eikonal solvers to account for anisotropy whenever it significantly affects the seismic wave kinematics. Moreover, computation of auxiliary quantities, such as amplitude and take-off angle, rely on highly accurate traveltime solutions. However, the finite-difference based eikonal solution for a point-source initial condition has an upwind source-singularity at the source position, since the wavefront curvature is large near the source point. Therefore, all finite-difference solvers, even the high-order ones, show inaccuracies since the errors due to source-singularity spread from the source point to the whole computational domain. We address the source-singularity problem for tilted transversely isotropic (TTI) eikonal solvers using factorization. We solve a sequence of factored tilted elliptically anisotropic (TEA) eikonal equations iteratively, each time by updating the right hand side function. At each iteration, we factor the unknown TEA traveltime into two factors. One of the factors is specified analytically, such that the other factor is smooth in the source neighborhood. Therefore, through the iterative procedure we obtain accurate solution to the TTI eikonal equation. Numerical tests show significant improvement in accuracy due to factorization. The idea can be easily extended to compute accurate traveltimes for models with lower anisotropic symmetries, such as orthorhombic, monoclinic or even triclinic media.

  15. A Highly Stable Marching-on-in-Time Volume Integral Equation Solver for Analyzing Transient Wave Interactions on High-Contrast Scatterers

    KAUST Repository

    Bagci, Hakan

    2014-01-06

    Time domain integral equation (TDIE) solvers represent an attractive alternative to finite difference (FDTD) and finite element (FEM) schemes for analyzing transient electromagnetic interactions on composite scatterers. Current induced on a scatterer, in response to a transient incident field, generates a scattered field. First, the scattered field is expressed as a spatio-temporal convolution of the current and the Green function of the background medium. Then, a TDIE is obtained by enforcing boundary conditions and/or fundamental field relations. TDIEs are often solved for the unknown current using marching on-in-time (MOT) schemes. MOT-TDIE solvers expand the current using local spatio-temporal basis functions. Inserting this expansion into the TDIE and testing the resulting equation in space and time yields a lower triangular system of equations (termed MOT system), which can be solved by marching in time for the coefficients of the current expansion. Stability of the MOT scheme often depends on how accurately the spatio-temporal convolution of the current and the Green function is discretized. In this work, band-limited prolate-based interpolation functions are used as temporal bases in expanding the current and discretizing the spatio-temporal convolution. Unfortunately, these functions are two sided, i.e., they require ”future” current samples for interpolation, resulting in a non-causal MOT system. To alleviate the effect of non-causality and restore the ability to march in time, an extrapolation scheme can be used to estimate the future values of the currents from their past values. Here, an accurate, stable and band-limited extrapolation scheme is developed for this purpose. This extrapolation scheme uses complex exponents, rather than commonly used harmonics, so that propagating and decaying mode fields inside the dielectric scatterers are accurately modeled. The resulting MOT scheme is applied to solving the time domain volume integral equation (VIE

  16. Minos: a SPN solver for core calculation in the DESCARTES system

    International Nuclear Information System (INIS)

    Baudron, A.M.; Lautard, J.J.

    2005-01-01

    This paper describes a new development of a neutronic core solver done in the context of a new generation neutronic reactor computational system, named DESCARTES. For performance reasons, the numerical method of the existing MINOS solver in the SAPHYR system has been reused in the new system. It is based on the mixed dual finite element approximation of the simplified transport equation. The solver takes into account assembly discontinuity coefficients (ADF) in the simplified transport equation (SPN) context. The solver has been rewritten in C++ programming language using an object oriented design. Its general architecture was reconsidered in order to improve its capability of evolution and its maintainability. Moreover, the performances of the old version have been improved mainly regarding the matrix construction time; this result improves significantly the performance of the solver in the context of industrial application requiring thermal hydraulic feedback and depletion calculations. (authors)

  17. Contributions to nonlinear elliptic equations and systems a tribute to Djairo Guedes de Figueiredo on the occasion of his 80th birthday

    CERN Document Server

    Ruf, Bernhard; Santos, Ederson; Gossez, Jean-Pierre; Soares, Sergio; Cazenave, Thierry

    2015-01-01

    This volume of contributions pays tribute to the life and work of Djairo Guedes de Figueiredo on the occasion of his 80th birthday. The articles it contains were born out of the ICMC Summer Meeting on Differential Equations – 2014 Chapter, also dedicated to de Figueiredo and held at the Universidade de São Paulo at São Carlos, Brazil from February 3-7, 2014. The contributing authors represent a group of international experts in the field and discuss recent trends and new directions in nonlinear elliptic partial differential equations and systems. Djairo Guedes de Figueiredo has had a very active scientific career, publishing 29 monographs and over one hundred research articles. His influence on Brazilian mathematics has made him one of the pillars of the subject in that country. He had a major impact on the development of analysis, especially in its application to nonlinear elliptic partial differential equations and systems throughout the entire world. The articles collected here pay tribute to him and h...

  18. Calculating qP-wave traveltimes in 2-D TTI media by high-order fast sweeping methods with a numerical quartic equation solver

    Science.gov (United States)

    Han, Song; Zhang, Wei; Zhang, Jie

    2017-09-01

    A fast sweeping method (FSM) determines the first arrival traveltimes of seismic waves by sweeping the velocity model in different directions meanwhile applying a local solver. It is an efficient way to numerically solve Hamilton-Jacobi equations for traveltime calculations. In this study, we develop an improved FSM to calculate the first arrival traveltimes of quasi-P (qP) waves in 2-D tilted transversely isotropic (TTI) media. A local solver utilizes the coupled slowness surface of qP and quasi-SV (qSV) waves to form a quartic equation, and solve it numerically to obtain possible traveltimes of qP-wave. The proposed quartic solver utilizes Fermat's principle to limit the range of the possible solution, then uses the bisection procedure to efficiently determine the real roots. With causality enforced during sweepings, our FSM converges fast in a few iterations, and the exact number depending on the complexity of the velocity model. To improve the accuracy, we employ high-order finite difference schemes and derive the second-order formulae. There is no weak anisotropy assumption, and no approximation is made to the complex slowness surface of qP-wave. In comparison to the traveltimes calculated by a horizontal slowness shooting method, the validity and accuracy of our FSM is demonstrated.

  19. Nonlinear Elliptic Differential Equations with Multivalued Nonlinearities

    Indian Academy of Sciences (India)

    In this paper we study nonlinear elliptic boundary value problems with monotone and nonmonotone multivalued nonlinearities. First we consider the case of monotone nonlinearities. In the first result we assume that the multivalued nonlinearity is defined on all R R . Assuming the existence of an upper and of a lower ...

  20. An explicit marching on-in-time solver for the time domain volume magnetic field integral equation

    KAUST Repository

    Sayed, Sadeed Bin

    2014-07-01

    Transient scattering from inhomogeneous dielectric objects can be modeled using time domain volume integral equations (TDVIEs). TDVIEs are oftentimes solved using marching on-in-time (MOT) techniques. Classical MOT-TDVIE solvers expand the field induced on the scatterer using local spatio-temporal basis functions. Inserting this expansion into the TDVIE and testing the resulting equation in space and time yields a system of equations that is solved by time marching. Depending on the type of the basis and testing functions and the time step, the time marching scheme can be implicit (N. T. Gres, et al., Radio Sci., 36(3), 379-386, 2001) or explicit (A. Al-Jarro, et al., IEEE Trans. Antennas Propag., 60(11), 5203-5214, 2012). Implicit MOT schemes are known to be more stable and accurate. However, under low-frequency excitation, i.e., when the time step size is large, they call for inversion of a full matrix system at very time step.

  1. An explicit marching on-in-time solver for the time domain volume magnetic field integral equation

    KAUST Repository

    Sayed, Sadeed Bin; Ulku, Huseyin Arda; Bagci, Hakan

    2014-01-01

    Transient scattering from inhomogeneous dielectric objects can be modeled using time domain volume integral equations (TDVIEs). TDVIEs are oftentimes solved using marching on-in-time (MOT) techniques. Classical MOT-TDVIE solvers expand the field induced on the scatterer using local spatio-temporal basis functions. Inserting this expansion into the TDVIE and testing the resulting equation in space and time yields a system of equations that is solved by time marching. Depending on the type of the basis and testing functions and the time step, the time marching scheme can be implicit (N. T. Gres, et al., Radio Sci., 36(3), 379-386, 2001) or explicit (A. Al-Jarro, et al., IEEE Trans. Antennas Propag., 60(11), 5203-5214, 2012). Implicit MOT schemes are known to be more stable and accurate. However, under low-frequency excitation, i.e., when the time step size is large, they call for inversion of a full matrix system at very time step.

  2. Fast solution of elliptic partial differential equations using linear combinations of plane waves.

    Science.gov (United States)

    Pérez-Jordá, José M

    2016-02-01

    Given an arbitrary elliptic partial differential equation (PDE), a procedure for obtaining its solution is proposed based on the method of Ritz: the solution is written as a linear combination of plane waves and the coefficients are obtained by variational minimization. The PDE to be solved is cast as a system of linear equations Ax=b, where the matrix A is not sparse, which prevents the straightforward application of standard iterative methods in order to solve it. This sparseness problem can be circumvented by means of a recursive bisection approach based on the fast Fourier transform, which makes it possible to implement fast versions of some stationary iterative methods (such as Gauss-Seidel) consuming O(NlogN) memory and executing an iteration in O(Nlog(2)N) time, N being the number of plane waves used. In a similar way, fast versions of Krylov subspace methods and multigrid methods can also be implemented. These procedures are tested on Poisson's equation expressed in adaptive coordinates. It is found that the best results are obtained with the GMRES method using a multigrid preconditioner with Gauss-Seidel relaxation steps.

  3. Numerical solver for compressible two-fluid flow

    NARCIS (Netherlands)

    J. Naber (Jorick)

    2005-01-01

    textabstractThis report treats the development of a numerical solver for the simulation of flows of two non-mixing fluids described by the two-dimensional Euler equations. A level-set equation in conservative form describes the interface. After each time step the deformed level-set function is

  4. Verification of continuum drift kinetic equation solvers in NIMROD

    Energy Technology Data Exchange (ETDEWEB)

    Held, E. D.; Ji, J.-Y. [Utah State University, Logan, Utah 84322-4415 (United States); Kruger, S. E. [Tech-X Corporation, Boulder, Colorado 80303 (United States); Belli, E. A. [General Atomics, San Diego, California 92186-5608 (United States); Lyons, B. C. [Program in Plasma Physics, Princeton University, Princeton, New Jersey 08543-0451 (United States)

    2015-03-15

    Verification of continuum solutions to the electron and ion drift kinetic equations (DKEs) in NIMROD [C. R. Sovinec et al., J. Comp. Phys. 195, 355 (2004)] is demonstrated through comparison with several neoclassical transport codes, most notably NEO [E. A. Belli and J. Candy, Plasma Phys. Controlled Fusion 54, 015015 (2012)]. The DKE solutions use NIMROD's spatial representation, 2D finite-elements in the poloidal plane and a 1D Fourier expansion in toroidal angle. For 2D velocity space, a novel 1D expansion in finite elements is applied for the pitch angle dependence and a collocation grid is used for the normalized speed coordinate. The full, linearized Coulomb collision operator is kept and shown to be important for obtaining quantitative results. Bootstrap currents, parallel ion flows, and radial particle and heat fluxes show quantitative agreement between NIMROD and NEO for a variety of tokamak equilibria. In addition, velocity space distribution function contours for ions and electrons show nearly identical detailed structure and agree quantitatively. A Θ-centered, implicit time discretization and a block-preconditioned, iterative linear algebra solver provide efficient electron and ion DKE solutions that ultimately will be used to obtain closures for NIMROD's evolving fluid model.

  5. Elliptic Tales Curves, Counting, and Number Theory

    CERN Document Server

    Ash, Avner

    2012-01-01

    Elliptic Tales describes the latest developments in number theory by looking at one of the most exciting unsolved problems in contemporary mathematics--the Birch and Swinnerton-Dyer Conjecture. The Clay Mathematics Institute is offering a prize of 1 million to anyone who can discover a general solution to the problem. In this book, Avner Ash and Robert Gross guide readers through the mathematics they need to understand this captivating problem. The key to the conjecture lies in elliptic curves, which are cubic equations in two variables. These equations may appear simple, yet they arise from

  6. On the Dirichlet problem for an elliptic equation

    Directory of Open Access Journals (Sweden)

    Anatolii K. Gushchin

    2015-03-01

    Full Text Available It is well known that the concept of a generalized solution from the Sobolev space $ W_2 ^ 1 $ of the Dirichlet problem for a second order elliptic equation is not a generalization of the classical solution sensu stricto: not every continuous function on the domain boundary is a trace of some function from $ W_2 ^ 1$. The present work is dedicated to the memory of Valentin Petrovich Mikhailov, who proposed a generalization of both these concepts. In the Mikhailov's definition the boundary values of the solution are taken from the $ L_2 $; this definition extends naturally to the case of boundary functions from $ L_p$, $p> 1 $. Subsequently, the author of this work has shown that solutions have the property $ (n-1 $-dimensional continuity; $ n $ is a dimension of the space in which we consider the problem. This property is similar to the classical definition of uniform continuity, but traces of this function on the measures from a special class should be considered instead of values of the function at points. This class is a little more narrow than the class of Carleson measures. The trace of function on the measure is an element of $ L_p $ with respect to this measure. The property $ (n-1 $-dimensional continuity makes it possible to give another definition of the solution of the Dirichlet problem (a definition of $(n-1$-dimensionally continuous solution, which is in the form close to the classical one. This definition does not require smoothness of the boundary. The Dirichlet problem in the Mikhailov's formulation and especially for the $(n-1$-dimensionally continuous solution was studied insufficiently (in contrast to the cases of classical and generalized solutions. First of all, it refers to conditions on the right side of the equation, in which the Dirichlet problem is solvable. In this article the new results in this direction are presented. In addition, we discuss the conditions on the coefficients of the equation and the conditions on

  7. An efficient Helmholtz solver for acoustic transversely isotropic media

    KAUST Repository

    Wu, Zedong

    2017-11-11

    The acoustic approximation, even for anisotropic media, is widely used in current industry imaging and inversion algorithms mainly because P-waves constitute the majority of the energy recorded in seismic exploration. The resulting acoustic formulas tend to be simpler, resulting in more efficient implementations, and depend on less medium parameters. However, conventional solutions of the acoustic wave equation with higher-order derivatives suffer from S-wave artifacts. Thus, we propose to separate the quasi-P wave propagation in anisotropic media into the elliptic anisotropic operator (free of the artifacts) and the non-elliptic-anisotropic components, which form a pseudo-differential operator. We, then, develop a separable approximation of the dispersion relation of non-elliptic-anisotropic components, specifically for transversely isotropic (TI) media. Finally, we iteratively solve the simpler lower-order elliptical wave equation for a modified source function that includes the non-elliptical terms represented in the Fourier domain. A frequency domain Helmholtz formulation of the approach renders the iterative implementation efficient as the cost is dominated by the Lower-Upper (LU) decomposition of the impedance matrix for the simpler elliptical anisotropic model. Also, the resulting wavefield is free of S-wave artifacts and has balanced amplitude. Numerical examples show that the method is reasonably accurate and efficient.

  8. An efficient Helmholtz solver for acoustic transversely isotropic media

    KAUST Repository

    Wu, Zedong; Alkhalifah, Tariq Ali

    2017-01-01

    The acoustic approximation, even for anisotropic media, is widely used in current industry imaging and inversion algorithms mainly because P-waves constitute the majority of the energy recorded in seismic exploration. The resulting acoustic formulas tend to be simpler, resulting in more efficient implementations, and depend on less medium parameters. However, conventional solutions of the acoustic wave equation with higher-order derivatives suffer from S-wave artifacts. Thus, we propose to separate the quasi-P wave propagation in anisotropic media into the elliptic anisotropic operator (free of the artifacts) and the non-elliptic-anisotropic components, which form a pseudo-differential operator. We, then, develop a separable approximation of the dispersion relation of non-elliptic-anisotropic components, specifically for transversely isotropic (TI) media. Finally, we iteratively solve the simpler lower-order elliptical wave equation for a modified source function that includes the non-elliptical terms represented in the Fourier domain. A frequency domain Helmholtz formulation of the approach renders the iterative implementation efficient as the cost is dominated by the Lower-Upper (LU) decomposition of the impedance matrix for the simpler elliptical anisotropic model. Also, the resulting wavefield is free of S-wave artifacts and has balanced amplitude. Numerical examples show that the method is reasonably accurate and efficient.

  9. Asymptotic behaviour and stability of solutions of a singularly perturbed elliptic problem with a triple root of the degenerate equation

    Science.gov (United States)

    Butuzov, V. F.

    2017-06-01

    We construct and justify asymptotic expansions of solutions of a singularly perturbed elliptic problem with Dirichlet boundary conditions in the case when the corresponding degenerate equation has a triple root. In contrast to the case of a simple root, the expansion is with respect to fractional (non-integral) powers of the small parameter, the boundary-layer variables have another scaling, and the boundary layer has three zones. This gives rise to essential modifications in the algorithm for constructing the boundary functions. Solutions of the elliptic problem are stationary solutions of the corresponding parabolic problem. We prove that such a stationary solution is asymptotically stable and find its global domain of attraction.

  10. A generalized Poisson and Poisson-Boltzmann solver for electrostatic environments

    International Nuclear Information System (INIS)

    Fisicaro, G.; Goedecker, S.; Genovese, L.; Andreussi, O.; Marzari, N.

    2016-01-01

    The computational study of chemical reactions in complex, wet environments is critical for applications in many fields. It is often essential to study chemical reactions in the presence of applied electrochemical potentials, taking into account the non-trivial electrostatic screening coming from the solvent and the electrolytes. As a consequence, the electrostatic potential has to be found by solving the generalized Poisson and the Poisson-Boltzmann equations for neutral and ionic solutions, respectively. In the present work, solvers for both problems have been developed. A preconditioned conjugate gradient method has been implemented for the solution of the generalized Poisson equation and the linear regime of the Poisson-Boltzmann, allowing to solve iteratively the minimization problem with some ten iterations of the ordinary Poisson equation solver. In addition, a self-consistent procedure enables us to solve the non-linear Poisson-Boltzmann problem. Both solvers exhibit very high accuracy and parallel efficiency and allow for the treatment of periodic, free, and slab boundary conditions. The solver has been integrated into the BigDFT and Quantum-ESPRESSO electronic-structure packages and will be released as an independent program, suitable for integration in other codes

  11. A generalized Poisson and Poisson-Boltzmann solver for electrostatic environments.

    Science.gov (United States)

    Fisicaro, G; Genovese, L; Andreussi, O; Marzari, N; Goedecker, S

    2016-01-07

    The computational study of chemical reactions in complex, wet environments is critical for applications in many fields. It is often essential to study chemical reactions in the presence of applied electrochemical potentials, taking into account the non-trivial electrostatic screening coming from the solvent and the electrolytes. As a consequence, the electrostatic potential has to be found by solving the generalized Poisson and the Poisson-Boltzmann equations for neutral and ionic solutions, respectively. In the present work, solvers for both problems have been developed. A preconditioned conjugate gradient method has been implemented for the solution of the generalized Poisson equation and the linear regime of the Poisson-Boltzmann, allowing to solve iteratively the minimization problem with some ten iterations of the ordinary Poisson equation solver. In addition, a self-consistent procedure enables us to solve the non-linear Poisson-Boltzmann problem. Both solvers exhibit very high accuracy and parallel efficiency and allow for the treatment of periodic, free, and slab boundary conditions. The solver has been integrated into the BigDFT and Quantum-ESPRESSO electronic-structure packages and will be released as an independent program, suitable for integration in other codes.

  12. A generalized Poisson and Poisson-Boltzmann solver for electrostatic environments

    Energy Technology Data Exchange (ETDEWEB)

    Fisicaro, G., E-mail: giuseppe.fisicaro@unibas.ch; Goedecker, S. [Department of Physics, University of Basel, Klingelbergstrasse 82, 4056 Basel (Switzerland); Genovese, L. [University of Grenoble Alpes, CEA, INAC-SP2M, L-Sim, F-38000 Grenoble (France); Andreussi, O. [Institute of Computational Science, Università della Svizzera Italiana, Via Giuseppe Buffi 13, CH-6904 Lugano (Switzerland); Theory and Simulations of Materials (THEOS) and National Centre for Computational Design and Discovery of Novel Materials (MARVEL), École Polytechnique Fédérale de Lausanne, Station 12, CH-1015 Lausanne (Switzerland); Marzari, N. [Theory and Simulations of Materials (THEOS) and National Centre for Computational Design and Discovery of Novel Materials (MARVEL), École Polytechnique Fédérale de Lausanne, Station 12, CH-1015 Lausanne (Switzerland)

    2016-01-07

    The computational study of chemical reactions in complex, wet environments is critical for applications in many fields. It is often essential to study chemical reactions in the presence of applied electrochemical potentials, taking into account the non-trivial electrostatic screening coming from the solvent and the electrolytes. As a consequence, the electrostatic potential has to be found by solving the generalized Poisson and the Poisson-Boltzmann equations for neutral and ionic solutions, respectively. In the present work, solvers for both problems have been developed. A preconditioned conjugate gradient method has been implemented for the solution of the generalized Poisson equation and the linear regime of the Poisson-Boltzmann, allowing to solve iteratively the minimization problem with some ten iterations of the ordinary Poisson equation solver. In addition, a self-consistent procedure enables us to solve the non-linear Poisson-Boltzmann problem. Both solvers exhibit very high accuracy and parallel efficiency and allow for the treatment of periodic, free, and slab boundary conditions. The solver has been integrated into the BigDFT and Quantum-ESPRESSO electronic-structure packages and will be released as an independent program, suitable for integration in other codes.

  13. A multi-solver quasi-Newton method for the partitioned simulation of fluid-structure interaction

    International Nuclear Information System (INIS)

    Degroote, J; Annerel, S; Vierendeels, J

    2010-01-01

    In partitioned fluid-structure interaction simulations, the flow equations and the structural equations are solved separately. Consequently, the stresses and displacements on both sides of the fluid-structure interface are not automatically in equilibrium. Coupling techniques like Aitken relaxation and the Interface Block Quasi-Newton method with approximate Jacobians from Least-Squares models (IBQN-LS) enforce this equilibrium, even with black-box solvers. However, all existing coupling techniques use only one flow solver and one structural solver. To benefit from the large number of multi-core processors in modern clusters, a new Multi-Solver Interface Block Quasi-Newton (MS-IBQN-LS) algorithm has been developed. This algorithm uses more than one flow solver and structural solver, each running in parallel on a number of cores. One-dimensional and three-dimensional numerical experiments demonstrate that the run time of a simulation decreases as the number of solvers increases, albeit at a slower pace. Hence, the presented multi-solver algorithm accelerates fluid-structure interaction calculations by increasing the number of solvers, especially when the run time does not decrease further if more cores are used per solver.

  14. Comparison of different Maxwell solvers coupled to a PIC resolution method of Maxwell-Vlasov equations

    International Nuclear Information System (INIS)

    Fochesato, Ch.; Bouche, D.

    2007-01-01

    The numerical solution of Maxwell equations is a challenging task. Moreover, the range of applications is very wide: microwave devices, diffraction, to cite a few. As a result, a number of methods have been proposed since the sixties. However, among all these methods, none has proved to be free of drawbacks. The finite difference scheme proposed by Yee in 1966, is well suited for Maxwell equations. However, it only works on cubical mesh. As a result, the boundaries of complex objects are not properly handled by the scheme. When classical nodal finite elements are used, spurious modes appear, which spoil the results of simulations. Edge elements overcome this problem, at the price of rather complex implementation, and computationally intensive simulations. Finite volume methods, either generalizing Yee scheme to a wider class of meshes, or applying to Maxwell equations methods initially used in the field of hyperbolic systems of conservation laws, are also used. Lastly, 'Discontinuous Galerkin' methods, generalizing to arbitrary order of accuracy finite volume methods, have recently been applied to Maxwell equations. In this report, we more specifically focus on the coupling of a Maxwell solver to a PIC (Particle-in-cell) method. We analyze advantages and drawbacks of the most widely used methods: accuracy, robustness, sensitivity to numerical artefacts, efficiency, user judgment. (authors)

  15. A deflation based parallel algorithm for spectral element solution of the incompressible Navier-Stokes equations

    Energy Technology Data Exchange (ETDEWEB)

    Fischer, P.F. [Brown Univ., Providence, RI (United States)

    1996-12-31

    Efficient solution of the Navier-Stokes equations in complex domains is dependent upon the availability of fast solvers for sparse linear systems. For unsteady incompressible flows, the pressure operator is the leading contributor to stiffness, as the characteristic propagation speed is infinite. In the context of operator splitting formulations, it is the pressure solve which is the most computationally challenging, despite its elliptic origins. We seek to improve existing spectral element iterative methods for the pressure solve in order to overcome the slow convergence frequently observed in the presence of highly refined grids or high-aspect ratio elements.

  16. ELLIPT2D: A Flexible Finite Element Code Written Python

    International Nuclear Information System (INIS)

    Pletzer, A.; Mollis, J.C.

    2001-01-01

    The use of the Python scripting language for scientific applications and in particular to solve partial differential equations is explored. It is shown that Python's rich data structure and object-oriented features can be exploited to write programs that are not only significantly more concise than their counter parts written in Fortran, C or C++, but are also numerically efficient. To illustrate this, a two-dimensional finite element code (ELLIPT2D) has been written. ELLIPT2D provides a flexible and easy-to-use framework for solving a large class of second-order elliptic problems. The program allows for structured or unstructured meshes. All functions defining the elliptic operator are user supplied and so are the boundary conditions, which can be of Dirichlet, Neumann or Robbins type. ELLIPT2D makes extensive use of dictionaries (hash tables) as a way to represent sparse matrices.Other key features of the Python language that have been widely used include: operator over loading, error handling, array slicing, and the Tkinter module for building graphical use interfaces. As an example of the utility of ELLIPT2D, a nonlinear solution of the Grad-Shafranov equation is computed using a Newton iterative scheme. A second application focuses on a solution of the toroidal Laplace equation coupled to a magnetohydrodynamic stability code, a problem arising in the context of magnetic fusion research

  17. Thermodynamics of Inozemtsev's elliptic spin chain

    International Nuclear Information System (INIS)

    Klabbers, Rob

    2016-01-01

    We study the thermodynamic behaviour of Inozemtsev's long-range elliptic spin chain using the Bethe ansatz equations describing the spectrum of the model in the infinite-length limit. We classify all solutions of these equations in that limit and argue which of these solutions determine the spectrum in the thermodynamic limit. Interestingly, some of the solutions are not selfconjugate, which puts the model in sharp contrast to one of the model's limiting cases, the Heisenberg XXX spin chain. Invoking the string hypothesis we derive the thermodynamic Bethe ansatz equations (TBA-equations) from which we determine the Helmholtz free energy in thermodynamic equilibrium and derive the associated Y-system. We corroborate our results by comparing numerical solutions of the TBA-equations to a direct computation of the free energy for the finite-length hamiltonian. In addition we confirm numerically the interesting conjecture put forward by Finkel and González-López that the original and supersymmetric versions of Inozemtsev's elliptic spin chain are equivalent in the thermodynamic limit.

  18. A boundary-value problem in weighted Hölder spaces for elliptic equations which degenerate at the boundary of the domain

    Energy Technology Data Exchange (ETDEWEB)

    Bazalii, B V; Degtyarev, S P [Institute of Applied Mathematics and Mechanics, National Academy of Sciences of Ukraine, Donetsk (Ukraine)

    2013-07-31

    An elliptic boundary-value problem for second-order equations with nonnegative characteristic form is investigated in the situation when there is a weak degeneracy on the boundary of the domain. A priori estimates are obtained for solutions and the problem is proved to be solvable in some weighted Hölder spaces. Bibliography: 18 titles.

  19. Status and Perspective of the Hydraulic Solver development for SPACE code

    International Nuclear Information System (INIS)

    Lee, S. Y.; Oh, M. T.; Park, J. C.; Ahn, S. J.; Park, C. E.; Lee, E. J.; Na, Y. W.

    2008-01-01

    KOPEC has been developing a hydraulic solver for SPACE code. The governing equations for the solver can be obtained through several steps of modeling and approximations from the basic material transport principles. Once the governing equations are fixed, a proper discretization procedure should be followed to get the difference equations that can be solved by well established matrix solvers. Of course, the mesh generation and handling procedures are necessary for the discretization process. At present, the preliminary test version has been constructed and being tested. The selection of the compiler language was debated openly. C++ was chosen as a basis compiler language. But other language such as FORTRAN can be used as it is necessary. The steps mentioned above are explained in the following sections. Test results are presented by other companion papers in this meeting. Future activities will be described in the conclusion section

  20. Scalable Newton-Krylov solver for very large power flow problems

    NARCIS (Netherlands)

    Idema, R.; Lahaye, D.J.P.; Vuik, C.; Van der Sluis, L.

    2010-01-01

    The power flow problem is generally solved by the Newton-Raphson method with a sparse direct solver for the linear system of equations in each iteration. While this works fine for small power flow problems, we will show that for very large problems the direct solver is very slow and we present

  1. Flows of non-smooth vector fields and degenerate elliptic equations with applications to the Vlasov-Poisson and semigeostrophic systems

    CERN Document Server

    Colombo, Maria

    2017-01-01

    The first part of the book is devoted to the transport equation for a given vector field, exploiting the lagrangian structure of solutions. It also treats the regularity of solutions of some degenerate elliptic equations, which appear in the eulerian counterpart of some transport models with congestion. The second part of the book deals with the lagrangian structure of solutions of the Vlasov-Poisson system, which describes the evolution of a system of particles under the self-induced gravitational/electrostatic field, and the existence of solutions of the semigeostrophic system, used in meteorology to describe the motion of large-scale oceanic/atmospheric flows.

  2. Iterative solution of the inverse Cauchy problem for an elliptic equation by the conjugate gradient method

    Science.gov (United States)

    Vasil'ev, V. I.; Kardashevsky, A. M.; Popov, V. V.; Prokopev, G. A.

    2017-10-01

    This article presents results of computational experiment carried out using a finite-difference method for solving the inverse Cauchy problem for a two-dimensional elliptic equation. The computational algorithm involves an iterative determination of the missing boundary condition from the override condition using the conjugate gradient method. The results of calculations are carried out on the examples with exact solutions as well as at specifying an additional condition with random errors are presented. Results showed a high efficiency of the iterative method of conjugate gradients for numerical solution

  3. New iterative solvers for the NAG Libraries

    Energy Technology Data Exchange (ETDEWEB)

    Salvini, S.; Shaw, G. [Numerical Algorithms Group Ltd., Oxford (United Kingdom)

    1996-12-31

    The purpose of this paper is to introduce the work which has been carried out at NAG Ltd to update the iterative solvers for sparse systems of linear equations, both symmetric and unsymmetric, in the NAG Fortran 77 Library. Our current plans to extend this work and include it in our other numerical libraries in our range are also briefly mentioned. We have added to the Library the new Chapter F11, entirely dedicated to sparse linear algebra. At Mark 17, the F11 Chapter includes sparse iterative solvers, preconditioners, utilities and black-box routines for sparse symmetric (both positive-definite and indefinite) linear systems. Mark 18 will add solvers, preconditioners, utilities and black-boxes for sparse unsymmetric systems: the development of these has already been completed.

  4. Refined isogeometric analysis for a preconditioned conjugate gradient solver

    KAUST Repository

    Garcia, Daniel

    2018-02-12

    Starting from a highly continuous Isogeometric Analysis (IGA) discretization, refined Isogeometric Analysis (rIGA) introduces C0 hyperplanes that act as separators for the direct LU factorization solver. As a result, the total computational cost required to solve the corresponding system of equations using a direct LU factorization solver dramatically reduces (up to a factor of 55) Garcia et al. (2017). At the same time, rIGA enriches the IGA spaces, thus improving the best approximation error. In this work, we extend the complexity analysis of rIGA to the case of iterative solvers. We build an iterative solver as follows: we first construct the Schur complements using a direct solver over small subdomains (macro-elements). We then assemble those Schur complements into a global skeleton system. Subsequently, we solve this system iteratively using Conjugate Gradients (CG) with an incomplete LU (ILU) preconditioner. For a 2D Poisson model problem with a structured mesh and a uniform polynomial degree of approximation, rIGA achieves moderate savings with respect to IGA in terms of the number of Floating Point Operations (FLOPs) and computational time (in seconds) required to solve the resulting system of linear equations. For instance, for a mesh with four million elements and polynomial degree p=3, the iterative solver is approximately 2.6 times faster (in time) when applied to the rIGA system than to the IGA one. These savings occur because the skeleton rIGA system contains fewer non-zero entries than the IGA one. The opposite situation occurs for 3D problems, and as a result, 3D rIGA discretizations provide no gains with respect to their IGA counterparts when considering iterative solvers.

  5. Seiberg-Witten curves and double-elliptic integrable systems

    International Nuclear Information System (INIS)

    Aminov, G.; Braden, H.W.; Mironov, A.; Morozov, A.; Zotov, A.

    2015-01-01

    An old conjecture claims that commuting Hamiltonians of the double-elliptic integrable system are constructed from the theta-functions associated with Riemann surfaces from the Seiberg-Witten family, with moduli treated as dynamical variables and the Seiberg-Witten differential providing the pre-symplectic structure. We describe a number of theta-constant equations needed to prove this conjecture for the N-particle system. These equations provide an alternative method to derive the Seiberg-Witten prepotential and we illustrate this by calculating the perturbative contribution. We provide evidence that the solutions to the commutativity equations are exhausted by the double-elliptic system and its degenerations (Calogero and Ruijsenaars systems). Further, the theta-function identities that lie behind the Poisson commutativity of the three-particle Hamiltonians are proven.

  6. Solving the Coupled System Improves Computational Efficiency of the Bidomain Equations

    KAUST Repository

    Southern, J.A.

    2009-10-01

    The bidomain equations are frequently used to model the propagation of cardiac action potentials across cardiac tissue. At the whole organ level, the size of the computational mesh required makes their solution a significant computational challenge. As the accuracy of the numerical solution cannot be compromised, efficiency of the solution technique is important to ensure that the results of the simulation can be obtained in a reasonable time while still encapsulating the complexities of the system. In an attempt to increase efficiency of the solver, the bidomain equations are often decoupled into one parabolic equation that is computationally very cheap to solve and an elliptic equation that is much more expensive to solve. In this study, the performance of this uncoupled solution method is compared with an alternative strategy in which the bidomain equations are solved as a coupled system. This seems counterintuitive as the alternative method requires the solution of a much larger linear system at each time step. However, in tests on two 3-D rabbit ventricle benchmarks, it is shown that the coupled method is up to 80% faster than the conventional uncoupled method-and that parallel performance is better for the larger coupled problem.

  7. Solving the Coupled System Improves Computational Efficiency of the Bidomain Equations

    KAUST Repository

    Southern, J.A.; Plank, G.; Vigmond, E.J.; Whiteley, J.P.

    2009-01-01

    The bidomain equations are frequently used to model the propagation of cardiac action potentials across cardiac tissue. At the whole organ level, the size of the computational mesh required makes their solution a significant computational challenge. As the accuracy of the numerical solution cannot be compromised, efficiency of the solution technique is important to ensure that the results of the simulation can be obtained in a reasonable time while still encapsulating the complexities of the system. In an attempt to increase efficiency of the solver, the bidomain equations are often decoupled into one parabolic equation that is computationally very cheap to solve and an elliptic equation that is much more expensive to solve. In this study, the performance of this uncoupled solution method is compared with an alternative strategy in which the bidomain equations are solved as a coupled system. This seems counterintuitive as the alternative method requires the solution of a much larger linear system at each time step. However, in tests on two 3-D rabbit ventricle benchmarks, it is shown that the coupled method is up to 80% faster than the conventional uncoupled method-and that parallel performance is better for the larger coupled problem.

  8. RELATIVISTIC MAGNETOHYDRODYNAMICS: RENORMALIZED EIGENVECTORS AND FULL WAVE DECOMPOSITION RIEMANN SOLVER

    International Nuclear Information System (INIS)

    Anton, Luis; MartI, Jose M; Ibanez, Jose M; Aloy, Miguel A.; Mimica, Petar; Miralles, Juan A.

    2010-01-01

    We obtain renormalized sets of right and left eigenvectors of the flux vector Jacobians of the relativistic MHD equations, which are regular and span a complete basis in any physical state including degenerate ones. The renormalization procedure relies on the characterization of the degeneracy types in terms of the normal and tangential components of the magnetic field to the wave front in the fluid rest frame. Proper expressions of the renormalized eigenvectors in conserved variables are obtained through the corresponding matrix transformations. Our work completes previous analysis that present different sets of right eigenvectors for non-degenerate and degenerate states, and can be seen as a relativistic generalization of earlier work performed in classical MHD. Based on the full wave decomposition (FWD) provided by the renormalized set of eigenvectors in conserved variables, we have also developed a linearized (Roe-type) Riemann solver. Extensive testing against one- and two-dimensional standard numerical problems allows us to conclude that our solver is very robust. When compared with a family of simpler solvers that avoid the knowledge of the full characteristic structure of the equations in the computation of the numerical fluxes, our solver turns out to be less diffusive than HLL and HLLC, and comparable in accuracy to the HLLD solver. The amount of operations needed by the FWD solver makes it less efficient computationally than those of the HLL family in one-dimensional problems. However, its relative efficiency increases in multidimensional simulations.

  9. Convective heat transfer from a heated elliptic cylinder at uniform wall temperature

    Energy Technology Data Exchange (ETDEWEB)

    Kaprawi, S.; Santoso, Dyos [Mechanical Department of Sriwijaya University, Jl. Raya Palembang-Prabumulih Km. 32 Inderalaya 50062 Ogan Ilir (Indonesia)

    2013-07-01

    This study is carried out to analyse the convective heat transfer from a circular and an elliptic cylinders to air. Both circular and elliptic cylinders have the same cross section. The aspect ratio of cylinders range 0-1 are studied. The implicit scheme of the finite difference is applied to obtain the discretized equations of hydrodynamic and thermal problem. The Choleski method is used to solve the discretized hydrodynamic equation and the iteration method is applied to solve the discretized thermal equation. The circular cylinder has the aspect ratio equal to unity while the elliptical cylinder has the aspect ratio less than unity by reducing the minor axis and increasing the major axis to obtain the same cross section as circular cylinder. The results of the calculations show that the skin friction change significantly, but in contrast with the elliptical cylinders have greater convection heat transfer than that of circular cylinder. Some results of calculations are compared to the analytical solutions given by the previous authors.

  10. The extended Fan's sub-equation method and its application to KdV-MKdV, BKK and variant Boussinesq equations

    International Nuclear Information System (INIS)

    Yomba, Emmanuel

    2005-01-01

    An extended Fan's sub-equation method is used for constructing exact travelling wave solutions of nonlinear partial differential equations (NLPDEs). The key idea of this method is to take full advantage of the general elliptic equation involving five parameters which has more new solutions and whose degeneracies can lead to special sub-equations involving three parameters. More new solutions are obtained for KdV-MKdV, Broer-Kaup-Kupershmidt (BKK) and variant Boussinesq equations. Then we present a technique which not only gives us a clear relation among this general elliptic equation and other sub-equations involving three parameters (Riccati equation, first kind elliptic equation, auxiliary ordinary equation, generalized Riccati equation and so on), but also provides an approach to construct new exact solutions to NLPDEs

  11. A Parallel Algebraic Multigrid Solver on Graphics Processing Units

    KAUST Repository

    Haase, Gundolf

    2010-01-01

    The paper presents a multi-GPU implementation of the preconditioned conjugate gradient algorithm with an algebraic multigrid preconditioner (PCG-AMG) for an elliptic model problem on a 3D unstructured grid. An efficient parallel sparse matrix-vector multiplication scheme underlying the PCG-AMG algorithm is presented for the many-core GPU architecture. A performance comparison of the parallel solver shows that a singe Nvidia Tesla C1060 GPU board delivers the performance of a sixteen node Infiniband cluster and a multi-GPU configuration with eight GPUs is about 100 times faster than a typical server CPU core. © 2010 Springer-Verlag.

  12. Estimates of azimuthal numbers associated with elementary elliptic cylinder wave functions

    Science.gov (United States)

    Kovalev, V. A.; Radaev, Yu. N.

    2014-05-01

    The paper deals with issues related to the construction of solutions, 2 π-periodic in the angular variable, of the Mathieu differential equation for the circular elliptic cylinder harmonics, the associated characteristic values, and the azimuthal numbers needed to form the elementary elliptic cylinder wave functions. A superposition of the latter is one possible form for representing the analytic solution of the thermoelastic wave propagation problem in long waveguides with elliptic cross-section contour. The classical Sturm-Liouville problem for the Mathieu equation is reduced to a spectral problem for a linear self-adjoint operator in the Hilbert space of infinite square summable two-sided sequences. An approach is proposed that permits one to derive rather simple algorithms for computing the characteristic values of the angular Mathieu equation with real parameters and the corresponding eigenfunctions. Priority is given to the application of the most symmetric forms and equations that have not yet been used in the theory of the Mathieu equation. These algorithms amount to constructing a matrix diagonalizing an infinite symmetric pentadiagonal matrix. The problem of generalizing the notion of azimuthal number of a wave propagating in a cylindrical waveguide to the case of elliptic geometry is considered. Two-sided mutually refining estimates are constructed for the spectral values of the Mathieu differential operator with periodic and half-periodic (antiperiodic) boundary conditions.

  13. Elliptic equations with measure data in Orlicz spaces

    Directory of Open Access Journals (Sweden)

    Ge Dong

    2008-05-01

    Full Text Available This article shows the existence of solutions to the nonlinear elliptic problem $A(u=f$ in Orlicz-Sobolev spaces with a measure valued right-hand side, where $A(u=-mathop{ m div}a(x,u, abla u$ is a Leray-Lions operator defined on a subset of $W_{0}^{1}L_{M}(Omega$, with general $M$.

  14. Polyharmonic boundary value problems positivity preserving and nonlinear higher order elliptic equations in bounded domains

    CERN Document Server

    Gazzola, Filippo; Sweers, Guido

    2010-01-01

    This monograph covers higher order linear and nonlinear elliptic boundary value problems in bounded domains, mainly with the biharmonic or poly-harmonic operator as leading principal part. Underlying models and, in particular, the role of different boundary conditions are explained in detail. As for linear problems, after a brief summary of the existence theory and Lp and Schauder estimates, the focus is on positivity or - since, in contrast to second order equations, a general form of a comparison principle does not exist - on “near positivity.” The required kernel estimates are also presented in detail. As for nonlinear problems, several techniques well-known from second order equations cannot be utilized and have to be replaced by new and different methods. Subcritical, critical and supercritical nonlinearities are discussed and various existence and nonexistence results are proved. The interplay with the positivity topic from the first part is emphasized and, moreover, a far-reaching Gidas-Ni-Nirenbe...

  15. Highly efficient parallel direct solver for solving dense complex matrix equations from method of moments

    Directory of Open Access Journals (Sweden)

    Yan Chen

    2017-03-01

    Full Text Available Based on the vectorised and cache optimised kernel, a parallel lower upper decomposition with a novel communication avoiding pivoting scheme is developed to solve dense complex matrix equations generated by the method of moments. The fine-grain data rearrangement and assembler instructions are adopted to reduce memory accessing times and improve CPU cache utilisation, which also facilitate vectorisation of the code. Through grouping processes in a binary tree, a parallel pivoting scheme is designed to optimise the communication pattern and thus reduces the solving time of the proposed solver. Two large electromagnetic radiation problems are solved on two supercomputers, respectively, and the numerical results demonstrate that the proposed method outperforms those in open source and commercial libraries.

  16. Effects of high-frequency damping on iterative convergence of implicit viscous solver

    Science.gov (United States)

    Nishikawa, Hiroaki; Nakashima, Yoshitaka; Watanabe, Norihiko

    2017-11-01

    This paper discusses effects of high-frequency damping on iterative convergence of an implicit defect-correction solver for viscous problems. The study targets a finite-volume discretization with a one parameter family of damped viscous schemes. The parameter α controls high-frequency damping: zero damping with α = 0, and larger damping for larger α (> 0). Convergence rates are predicted for a model diffusion equation by a Fourier analysis over a practical range of α. It is shown that the convergence rate attains its minimum at α = 1 on regular quadrilateral grids, and deteriorates for larger values of α. A similar behavior is observed for regular triangular grids. In both quadrilateral and triangular grids, the solver is predicted to diverge for α smaller than approximately 0.5. Numerical results are shown for the diffusion equation and the Navier-Stokes equations on regular and irregular grids. The study suggests that α = 1 and 4/3 are suitable values for robust and efficient computations, and α = 4 / 3 is recommended for the diffusion equation, which achieves higher-order accuracy on regular quadrilateral grids. Finally, a Jacobian-Free Newton-Krylov solver with the implicit solver (a low-order Jacobian approximately inverted by a multi-color Gauss-Seidel relaxation scheme) used as a variable preconditioner is recommended for practical computations, which provides robust and efficient convergence for a wide range of α.

  17. Development of axisymmetric lattice Boltzmann flux solver for complex multiphase flows

    Science.gov (United States)

    Wang, Yan; Shu, Chang; Yang, Li-Ming; Yuan, Hai-Zhuan

    2018-05-01

    This paper presents an axisymmetric lattice Boltzmann flux solver (LBFS) for simulating axisymmetric multiphase flows. In the solver, the two-dimensional (2D) multiphase LBFS is applied to reconstruct macroscopic fluxes excluding axisymmetric effects. Source terms accounting for axisymmetric effects are introduced directly into the governing equations. As compared to conventional axisymmetric multiphase lattice Boltzmann (LB) method, the present solver has the kinetic feature for flux evaluation and avoids complex derivations of external forcing terms. In addition, the present solver also saves considerable computational efforts in comparison with three-dimensional (3D) computations. The capability of the proposed solver in simulating complex multiphase flows is demonstrated by studying single bubble rising in a circular tube. The obtained results compare well with the published data.

  18. MINOS: A simplified Pn solver for core calculation

    International Nuclear Information System (INIS)

    Baudron, A.M.; Lautard, J.J.

    2007-01-01

    This paper describes a new generation of the neutronic core solver MINOS resulting from developments done in the DESCARTES project. For performance reasons, the numerical method of the existing MINOS solver in the SAPHYR system has been reused in the new system. It is based on the mixed-dual finite element approximation of the simplified transport equation. We have extended the previous method to the treatment of unstructured geometries composed by quadrilaterals, allowing us to treat geometries where fuel pins are exactly represented. For Cartesian geometries, the solver takes into account assembly discontinuity coefficients in the simplified P n context. The solver has been rewritten in C + + programming language using an object-oriented design. Its general architecture was reconsidered in order to improve its capability of evolution and its maintainability. Moreover, the performance of the previous version has been improved mainly regarding the matrix construction time; this result improves significantly the performance of the solver in the context of industrial application requiring thermal-hydraulic feedback and depletion calculations. (authors)

  19. Parallel Element Agglomeration Algebraic Multigrid and Upscaling Library

    Energy Technology Data Exchange (ETDEWEB)

    2017-10-24

    ParELAG is a parallel C++ library for numerical upscaling of finite element discretizations and element-based algebraic multigrid solvers. It provides optimal complexity algorithms to build multilevel hierarchies and solvers that can be used for solving a wide class of partial differential equations (elliptic, hyperbolic, saddle point problems) on general unstructured meshes. Additionally, a novel multilevel solver for saddle point problems with divergence constraint is implemented.

  20. Efficient time-symmetric simulation of torqued rigid bodies using Jacobi elliptic functions

    International Nuclear Information System (INIS)

    Celledoni, E; Saefstroem, N

    2006-01-01

    If the three moments of inertia are distinct, the solution to the Euler equations for the free rigid body is given in terms of Jacobi elliptic functions. Using the arithmetic-geometric mean algorithm (Abramowitz and Stegun 1992 Handbook of Mathematical Functions with Formulas, Graphs, and Mathematical Tables (New York: Dover)), these functions can be calculated efficiently and accurately. Compared to standard numerical ODE and Lie-Poisson solvers, the overall approach yields a faster and more accurate numerical solution to the Euler equations. This approach is designed for mass asymmetric rigid bodies. In the case of symmetric bodies, the exact solution is available in terms of trigonometric functions, see Dullweber et al (1997 J. Chem. Phys. 107 5840-51), Reich (1996 Fields Inst. Commun. 10 181-91) and Benettin et al (2001 SIAM J. Sci. Comp. 23 1189-203) for details. In this paper, we consider the case of asymmetric rigid bodies subject to external forces. We consider a strategy similar to the symplectic splitting method proposed in Reich (1996 Fields Inst. Commun. 10 181-91) and Dullweber et al (1997 J. Chem. Phys. 107 5840-51). The method proposed here is time-symmetric. We decompose the vector field of our problem into a free rigid body (FRB) problem and another completely integrable vector field. The FRB problem consists of the Euler equations and a differential equation for the 3 x 3 orientation matrix. The Euler equations are integrated exactly while the matrix equation is approximated using a truncated Magnus series. In our experiments, we observe that the overall numerical solution benefits greatly from the very accurate solution of the Euler equations. We apply the method to the heavy top and the simulation of artificial satellite attitude dynamics

  1. An Unsplit Monte-Carlo solver for the resolution of the linear Boltzmann equation coupled to (stiff) Bateman equations

    Science.gov (United States)

    Bernede, Adrien; Poëtte, Gaël

    2018-02-01

    In this paper, we are interested in the resolution of the time-dependent problem of particle transport in a medium whose composition evolves with time due to interactions. As a constraint, we want to use of Monte-Carlo (MC) scheme for the transport phase. A common resolution strategy consists in a splitting between the MC/transport phase and the time discretization scheme/medium evolution phase. After going over and illustrating the main drawbacks of split solvers in a simplified configuration (monokinetic, scalar Bateman problem), we build a new Unsplit MC (UMC) solver improving the accuracy of the solutions, avoiding numerical instabilities, and less sensitive to time discretization. The new solver is essentially based on a Monte Carlo scheme with time dependent cross sections implying the on-the-fly resolution of a reduced model for each MC particle describing the time evolution of the matter along their flight path.

  2. A User’s Guide to the SEVP (Stabilized Error Vector Propagation) Solver: An Efficient Direct Solver for Elliptic Partial Differential Equations

    Science.gov (United States)

    1989-04-13

    DIMENSION HXU(N),HXV(NI), HYU (N),HYV(N) DIMENSION AA(N),AC(N),CC(N) DIMENSION Tl(N),T2(N),T3(N),T4(N) DIMENSION DUM3(M,N) C SET COEFFICIENTS OF DIFFERENCE...DELXSQ=DELX*DELX DELYSQ=DELY*DELY C DEFINE MAP FACTORS DO 10 J=1,N HXU(J)=COS(Y(J)/AR) HYU (J)=I.O 10 CONTINUE 31 DO 20 J-1,Nl HXV(J)-0.5*(HXU(J)+HXU(J+l...L.H.S. OF DIFFERENCE EQUATION. C COEFFICIENTS DEFINED IN INTERIOR OF DOMAIN ONLY. DO 25 J=2,N-1, AA(J)=( (HXU(J)*HXV(J-1) )/I(HYV(J.-1)* HYU (J

  3. On a construction of fast direct solvers

    Czech Academy of Sciences Publication Activity Database

    Práger, Milan

    2003-01-01

    Roč. 48, č. 3 (2003), s. 225-236 ISSN 0862-7940 Institutional research plan: CEZ:AV0Z1019905; CEZ:AV0Z1019905 Keywords : Poisson equation * boundary value problem * fast direct solver Subject RIV: BA - General Mathematics

  4. Multiple solutions for a quasilinear (p,q-elliptic system

    Directory of Open Access Journals (Sweden)

    Seyyed Mohsen Khalkhali

    2013-06-01

    Full Text Available In this article we show the existence of three weak solutions of a Dirichlet quasilinear elliptic system of differential equations which involves a general (p,q-elliptic operator in divergence, with $1

  5. A fast direct solver for boundary value problems on locally perturbed geometries

    Science.gov (United States)

    Zhang, Yabin; Gillman, Adrianna

    2018-03-01

    Many applications including optimal design and adaptive discretization techniques involve solving several boundary value problems on geometries that are local perturbations of an original geometry. This manuscript presents a fast direct solver for boundary value problems that are recast as boundary integral equations. The idea is to write the discretized boundary integral equation on a new geometry as a low rank update to the discretized problem on the original geometry. Using the Sherman-Morrison formula, the inverse can be expressed in terms of the inverse of the original system applied to the low rank factors and the right hand side. Numerical results illustrate for problems where perturbation is localized the fast direct solver is three times faster than building a new solver from scratch.

  6. A dynamical regularization algorithm for solving inverse source problems of elliptic partial differential equations

    Science.gov (United States)

    Zhang, Ye; Gong, Rongfang; Cheng, Xiaoliang; Gulliksson, Mårten

    2018-06-01

    This study considers the inverse source problem for elliptic partial differential equations with both Dirichlet and Neumann boundary data. The unknown source term is to be determined by additional boundary conditions. Unlike the existing methods found in the literature, which usually employ the first-order in time gradient-like system (such as the steepest descent methods) for numerically solving the regularized optimization problem with a fixed regularization parameter, we propose a novel method with a second-order in time dissipative gradient-like system and a dynamical selected regularization parameter. A damped symplectic scheme is proposed for the numerical solution. Theoretical analysis is given for both the continuous model and the numerical algorithm. Several numerical examples are provided to show the robustness of the proposed algorithm.

  7. Development of a CANDU Moderator Analysis Model; Based on Coupled Solver

    International Nuclear Information System (INIS)

    Yoon, Churl; Park, Joo Hwan

    2006-01-01

    A CFD model for predicting the CANDU-6 moderator temperature has been developed for several years in KAERI, which is based on CFX-4. This analytic model(CFX4-CAMO) has some strength in the modeling of hydraulic resistance in the core region and in the treatment of heat source term in the energy equations. But the convergence difficulties and slow computing speed reveal to be the limitations of this model, because the CFX-4 code adapts a segregated solver to solve the governing equations with strong coupled-effect. Compared to CFX-4 using segregated solver, CFX-10 adapts high efficient and robust coupled-solver. Before December 2005 when CFX-10 was distributed, the previous version of CFX-10(CFX-5. series) also adapted coupled solver but didn't have any capability to apply porous media approaches correctly. In this study, the developed moderator analysis model based on CFX- 4 (CFX4-CAMO) is transformed into a new moderator analysis model based on CFX-10. The new model is examined and the results are compared to the former

  8. Radial, sideward and elliptic flow at AGS energies

    Indian Academy of Sciences (India)

    the sideward flow, the elliptic flow and the radial transverse mass distribution of protons data at. AGS energies. In order to ... data on both sideward and elliptic flow, NL3 model is better at 2 A¡GeV, while NL23 model is at 4–8. A¡GeV. ... port approach RBUU which is based on a coupled set of covariant transport equations for.

  9. A comparison of viscous-plastic sea ice solvers with and without replacement pressure

    Science.gov (United States)

    Kimmritz, Madlen; Losch, Martin; Danilov, Sergey

    2017-07-01

    Recent developments of the explicit elastic-viscous-plastic (EVP) solvers call for a new comparison with implicit solvers for the equations of viscous-plastic sea ice dynamics. In Arctic sea ice simulations, the modified and the adaptive EVP solvers, and the implicit Jacobian-free Newton-Krylov (JFNK) solver are compared against each other. The adaptive EVP method shows convergence rates that are generally similar or even better than those of the modified EVP method, but the convergence of the EVP methods is found to depend dramatically on the use of the replacement pressure (RP). Apparently, using the RP can affect the pseudo-elastic waves in the EVP methods by introducing extra non-physical oscillations so that, in the extreme case, convergence to the VP solution can be lost altogether. The JFNK solver also suffers from higher failure rates with RP implying that with RP the momentum equations are stiffer and more difficult to solve. For practical purposes, both EVP methods can be used efficiently with an unexpectedly low number of sub-cycling steps without compromising the solutions. The differences between the RP solutions and the NoRP solutions (when the RP is not being used) can be reduced with lower thresholds of viscous regularization at the cost of increasing stiffness of the equations, and hence the computational costs of solving them.

  10. Dirichlet problem for quasi-linear elliptic equations

    Directory of Open Access Journals (Sweden)

    Azeddine Baalal

    2002-10-01

    Full Text Available We study the Dirichlet Problem associated to the quasilinear elliptic problem $$ -sum_{i=1}^{n}frac{partial }{partial x_i}mathcal{A}_i(x,u(x, abla u(x+mathcal{B}(x,u(x,abla u(x=0. $$ Then we define a potential theory related to this problem and we show that the sheaf of continuous solutions satisfies the Bauer axiomatic theory. Submitted April 9, 2002. Published October 2, 2002. Math Subject Classifications: 31C15, 35B65, 35J60. Key Words: Supersolution; Dirichlet problem; obstacle problem; nonlinear potential theory.

  11. Sound Attenuation in Elliptic Mufflers Using a Regular Perturbation Method

    OpenAIRE

    Banerjee, Subhabrata; Jacobi, Anthony M.

    2012-01-01

    The study of sound attenuation in an elliptical chamber involves the solution of the Helmholtz equation in elliptic coordinate systems. The Eigen solutions for such problems involve the Mathieu and the modified Mathieu functions. The computation of such functions poses considerable challenge. An alternative method to solve such problems had been proposed in this paper. The elliptical cross-section of the muffler has been treated as a perturbed circle, enabling the use of a regular perturbatio...

  12. Electromagnetic Invisibility of Elliptic Cylinder Cloaks

    International Nuclear Information System (INIS)

    Kan, Yao; Chao, Li; Fang, Li

    2008-01-01

    Structures with unique electromagnetic properties are designed based on the approach of spatial coordinate transformations of Maxwell's equations. This approach is applied to scheme out invisible elliptic cylinder cloaks, which provide more feasibility for cloaking arbitrarily shaped objects. The transformation expressions for the anisotropic material parameters and the field distribution are derived. The cloaking performances of ideal and lossy elliptic cylinder cloaks are investigated by finite element simulations. It is found that the cloaking performance will degrade in the forward direction with increasing loss. (fundamental areas of phenomenology (including applications))

  13. GPU TECHNOLOGIES EMBODIED IN PARALLEL SOLVERS OF LINEAR ALGEBRAIC EQUATION SYSTEMS

    Directory of Open Access Journals (Sweden)

    Sidorov Alexander Vladimirovich

    2012-10-01

    Full Text Available The author reviews existing shareware solvers that are operated by graphical computer devices. The purpose of this review is to explore the opportunities and limitations of the above parallel solvers applicable for resolution of linear algebraic problems that arise at Research and Educational Centre of Computer Modeling at MSUCE, and Research and Engineering Centre STADYO. The author has explored new applications of the GPU in the PETSc suite and compared them with the results generated absent of the GPU. The research is performed within the CUSP library developed to resolve the problems of linear algebra through the application of GPU. The author has also reviewed the new MAGMA project which is analogous to LAPACK for the GPU.

  14. Simplified Eigen-structure decomposition solver for the simulation of two-phase flow systems

    International Nuclear Information System (INIS)

    Kumbaro, Anela

    2012-01-01

    This paper discusses the development of a new solver for a system of first-order non-linear differential equations that model the dynamics of compressible two-phase flow. The solver presents a lower-complexity alternative to Roe-type solvers because it only makes use of a partial Eigen-structure information while maintaining its accuracy: the outcome is hence a good complexity-tractability trade-off to consider as relevant in a large number of situations in the scope of two-phase flow numerical simulation. A number of numerical and physical benchmarks are presented to assess the solver. Comparison between the computational results from the simplified Eigen-structure decomposition solver and the conventional Roe-type solver gives insight upon the issues of accuracy, robustness and efficiency. (authors)

  15. Open problems in CEM: Porting an explicit time-domain volume-integral- equation solver on GPUs with OpenACC

    KAUST Repository

    Ergül, Özgür

    2014-04-01

    Graphics processing units (GPUs) are gradually becoming mainstream in high-performance computing, as their capabilities for enhancing performance of a large spectrum of scientific applications to many fold when compared to multi-core CPUs have been clearly identified and proven. In this paper, implementation and performance-tuning details for porting an explicit marching-on-in-time (MOT)-based time-domain volume-integral-equation (TDVIE) solver onto GPUs are described in detail. To this end, a high-level approach, utilizing the OpenACC directive-based parallel programming model, is used to minimize two often-faced challenges in GPU programming: developer productivity and code portability. The MOT-TDVIE solver code, originally developed for CPUs, is annotated with compiler directives to port it to GPUs in a fashion similar to how OpenMP targets multi-core CPUs. In contrast to CUDA and OpenCL, where significant modifications to CPU-based codes are required, this high-level approach therefore requires minimal changes to the codes. In this work, we make use of two available OpenACC compilers, CAPS and PGI. Our experience reveals that different annotations of the code are required for each of the compilers, due to different interpretations of the fairly new standard by the compiler developers. Both versions of the OpenACC accelerated code achieved significant performance improvements, with up to 30× speedup against the sequential CPU code using recent hardware technology. Moreover, we demonstrated that the GPU-accelerated fully explicit MOT-TDVIE solver leveraged energy-consumption gains of the order of 3× against its CPU counterpart. © 2014 IEEE.

  16. An impurity solver for nonequilibrium dynamical mean field theory based on hierarchical quantum master equations

    Energy Technology Data Exchange (ETDEWEB)

    Haertle, Rainer [Institut fuer Theoretische Physik, Georg-August-Universitaet Goettingen, Goettingen (Germany); Millis, Andrew J. [Department of Physics, Columbia University, New York (United States)

    2016-07-01

    We present a new impurity solver for real-time and nonequilibrium dynamical mean field theory applications, based on the recently developed hierarchical quantum master equation approach. Our method employs a hybridization expansion of the time evolution operator, including an advanced, systematic truncation scheme. Convergence to exact results for not too low temperatures has been demonstrated by a direct comparison to quantum Monte Carlo simulations. The approach is time-local, which gives us access to slow dynamics such as, e.g., in the presence of magnetic fields or exchange interactions and to nonequilibrium steady states. Here, we present first results of this new scheme for the description of strongly correlated materials in the framework of dynamical mean field theory, including benchmark and new results for the Hubbard and periodic Anderson model.

  17. Compatible discrete operator schemes on polyhedral meshes for elliptic and Stokes equations

    International Nuclear Information System (INIS)

    Bonelle, Jerome

    2014-01-01

    This thesis presents a new class of spatial discretization schemes on polyhedral meshes, called Compatible Discrete Operator (CDO) schemes and their application to elliptic and Stokes equations In CDO schemes, preserving the structural properties of the continuous equations is the leading principle to design the discrete operators. De Rham maps define the degrees of freedom according to the physical nature of fields to discretize. CDO schemes operate a clear separation between topological relations (balance equations) and constitutive relations (closure laws). Topological relations are related to discrete differential operators, and constitutive relations to discrete Hodge operators. A feature of CDO schemes is the explicit use of a second mesh, called dual mesh, to build the discrete Hodge operator. Two families of CDO schemes are considered: vertex-based schemes where the potential is located at (primal) mesh vertices, and cell-based schemes where the potential is located at dual mesh vertices (dual vertices being in one-to-one correspondence with primal cells). The CDO schemes related to these two families are presented and their convergence is analyzed. A first analysis hinges on an algebraic definition of the discrete Hodge operator and allows one to identify three key properties: symmetry, stability, and P0-consistency. A second analysis hinges on a definition of the discrete Hodge operator using reconstruction operators, and the requirements on these reconstruction operators are identified. In addition, CDO schemes provide a unified vision on a broad class of schemes proposed in the literature (finite element, finite element, mimetic schemes... ). Finally, the reliability and the efficiency of CDO schemes are assessed on various test cases and several polyhedral meshes. (author)

  18. Extending the Riemann-Solver-Free High-Order Space-Time Discontinuous Galerkin Cell Vertex Scheme (DG-CVS) to Solve Compressible Magnetohydrodynamics Equations

    Science.gov (United States)

    2016-06-08

    Ideal Magnetohydrodynamics,” J. Com- put. Phys., Vol. 153, No. 2, 1999, pp. 334–352. [14] Tang, H.-Z. and Xu, K., “A high-order gas -kinetic method for...notwithstanding any other provision of law , no person shall be subject to any penalty for failing to comply with a collection of information if it does...Riemann-solver-free spacetime discontinuous Galerkin method for general conservation laws to solve compressible magnetohydrodynamics (MHD) equations. The

  19. Thermodynamics of Inozemtsev's elliptic spin chain

    Energy Technology Data Exchange (ETDEWEB)

    Klabbers, Rob, E-mail: rob.klabbers@desy.de

    2016-06-15

    We study the thermodynamic behaviour of Inozemtsev's long-range elliptic spin chain using the Bethe ansatz equations describing the spectrum of the model in the infinite-length limit. We classify all solutions of these equations in that limit and argue which of these solutions determine the spectrum in the thermodynamic limit. Interestingly, some of the solutions are not selfconjugate, which puts the model in sharp contrast to one of the model's limiting cases, the Heisenberg XXX spin chain. Invoking the string hypothesis we derive the thermodynamic Bethe ansatz equations (TBA-equations) from which we determine the Helmholtz free energy in thermodynamic equilibrium and derive the associated Y-system. We corroborate our results by comparing numerical solutions of the TBA-equations to a direct computation of the free energy for the finite-length hamiltonian. In addition we confirm numerically the interesting conjecture put forward by Finkel and González-López that the original and supersymmetric versions of Inozemtsev's elliptic spin chain are equivalent in the thermodynamic limit.

  20. Acceleration of FDTD mode solver by high-performance computing techniques.

    Science.gov (United States)

    Han, Lin; Xi, Yanping; Huang, Wei-Ping

    2010-06-21

    A two-dimensional (2D) compact finite-difference time-domain (FDTD) mode solver is developed based on wave equation formalism in combination with the matrix pencil method (MPM). The method is validated for calculation of both real guided and complex leaky modes of typical optical waveguides against the bench-mark finite-difference (FD) eigen mode solver. By taking advantage of the inherent parallel nature of the FDTD algorithm, the mode solver is implemented on graphics processing units (GPUs) using the compute unified device architecture (CUDA). It is demonstrated that the high-performance computing technique leads to significant acceleration of the FDTD mode solver with more than 30 times improvement in computational efficiency in comparison with the conventional FDTD mode solver running on CPU of a standard desktop computer. The computational efficiency of the accelerated FDTD method is in the same order of magnitude of the standard finite-difference eigen mode solver and yet require much less memory (e.g., less than 10%). Therefore, the new method may serve as an efficient, accurate and robust tool for mode calculation of optical waveguides even when the conventional eigen value mode solvers are no longer applicable due to memory limitation.

  1. COMPUTER-AIDED DESIGN, MANUFACTURE AND EXPERIMENTAL ANALYSIS OF A PAIR OF ELLIPTICAL SPUR GEARS

    Directory of Open Access Journals (Sweden)

    Mehmet YAZAR

    2016-12-01

    Full Text Available ABSTRACT In this study, geometrical equations of elliptical spur gears, which are too difficult to manufacture by traditional methods and which require specific machines equipped with special techniques, are developed using the methods in the literature. Using these equations, a LISP program on AutoLISP is created to model elliptical spur gears on AutoCAD with desired tooth number and modules. Elliptical spur gears are manufactured with 5 different modules by Wire EDM through the above-mentioned package program. The variations in the center distances of elliptical spur gears, the most important parameter for workability of gears, are experimentally determined by a simple test unit designed and manufactured within the context this study. In addition, the surface roughness and hardness of elliptical spur gears are obtained and hydraulic pump and noise analysis results are discussed. The experimental and computer-aided results show that the elliptical spur gears may widely be used in many industrial and mechanical applications in the future.

  2. Symmetry in an elliptic problem and the blow-up set of a quasilinear heat equation

    Energy Technology Data Exchange (ETDEWEB)

    Cortazar, C.; Elgueta, M. [Universidad Catolica, Santiago (Chile); Felmer, P. [Universidad de Chile, Santiago (Chile)

    1996-12-31

    We will consider in this paper a semilinear elliptic equation {triangle}u + f(u) = 0 in {Omega}, (1.5) where the function f is locally Lipschitz in (0,{infinity}) and continuous in (0,{infinity}). We study symmetry properties of nonnegative solutions of this equation in two different situations: first we assume {Omega} = IR{sup N}, and second we consider {Omega} {ne} IR{sup N} and we provide (1.5) with overdetermined boundary conditions. Next we describe our results in the first case, that is, when {Omega} = IR{sup N}. We will consider the following hypothesis on the nonlinear function f (F) f(0) {le} 0, f continuous in (0,+{infinity}), locally Lipschitz in (0,+{infinity}) and there exists {alpha} > 0 so that f is strictly decreasing in [0,{alpha}]. We note that the support of a solution of (1.5) is not known a priori and so we have in fact a free boundary involved. Our goal is to determine the shape of this support and the symmetry properties of the solution.

  3. Stress-intensity factor equations for cracks in three-dimensional finite bodies

    Science.gov (United States)

    Newman, J. C., Jr.; Raju, I. S.

    1981-01-01

    Empirical stress intensity factor equations are presented for embedded elliptical cracks, semi-elliptical surface cracks, quarter-elliptical corner cracks, semi-elliptical surface cracks at a hole, and quarter-elliptical corner cracks at a hole in finite plates. The plates were subjected to remote tensile loading. Equations give stress intensity factors as a function of parametric angle, crack depth, crack length, plate thickness, and where applicable, hole radius. The stress intensity factors used to develop the equations were obtained from three dimensional finite element analyses of these crack configurations.

  4. Rational points on elliptic curves

    CERN Document Server

    Silverman, Joseph H

    2015-01-01

    The theory of elliptic curves involves a pleasing blend of algebra, geometry, analysis, and number theory. This book stresses this interplay as it develops the basic theory, thereby providing an opportunity for advanced undergraduates to appreciate the unity of modern mathematics. At the same time, every effort has been made to use only methods and results commonly included in the undergraduate curriculum. This accessibility, the informal writing style, and a wealth of exercises make Rational Points on Elliptic Curves an ideal introduction for students at all levels who are interested in learning about Diophantine equations and arithmetic geometry. Most concretely, an elliptic curve is the set of zeroes of a cubic polynomial in two variables. If the polynomial has rational coefficients, then one can ask for a description of those zeroes whose coordinates are either integers or rational numbers. It is this number theoretic question that is the main subject of this book. Topics covered include the geometry and ...

  5. Quasilinear infiltration from an elliptical cavity

    Science.gov (United States)

    Kuhlman, Kristopher L.; Warrick, Arthur W.

    2008-08-01

    We develop analytic solutions to the linearized steady-state Richards equation for head and total flowrate due to an elliptic cylinder cavity with a specified pressure head boundary condition. They are generalizations of the circular cylinder cavity solutions of Philip [Philip JR. Steady infiltration from circular cylindrical cavities. Soil Sci Soc Am J 1984;48:270-8]. The circular and strip sources are limiting cases of the elliptical cylinder solution, derived for both horizontally- and vertically-aligned ellipses. We give approximate rational polynomial expressions for total flowrate from an elliptical cylinder over a range of sizes and shapes. The exact elliptical solution is in terms of Mathieu functions, which themselves are generalizations of and computed from trigonometric and Bessel functions. The required Mathieu functions are computed from a matrix eigenvector problem, a modern approach that is straightforward to implement using available linear algebra libraries. Although less efficient and potentially less accurate than the iterative continued fraction approach, the matrix approach is simpler to understand and implement and is valid over a wider parameter range.

  6. Electron energy spectrum in core-shell elliptic quantum wire

    Directory of Open Access Journals (Sweden)

    V.Holovatsky

    2007-01-01

    Full Text Available The electron energy spectrum in core-shell elliptic quantum wire and elliptic semiconductor nanotubes are investigated within the effective mass approximation. The solution of Schrodinger equation based on the Mathieu functions is obtained in elliptic coordinates. The dependencies of the electron size quantization spectrum on the size and shape of the core-shell nanowire and nanotube are calculated. It is shown that the ellipticity of a quantum wire leads to break of degeneration of quasiparticle energy spectrum. The dependences of the energy of odd and even electron states on the ratio between semiaxes are of a nonmonotonous character. The anticrosing effects are observed at the dependencies of electron energy spectrum on the transversal size of the core-shell nanowire.

  7. User's Manual for PCSMS (Parallel Complex Sparse Matrix Solver). Version 1.

    Science.gov (United States)

    Reddy, C. J.

    2000-01-01

    PCSMS (Parallel Complex Sparse Matrix Solver) is a computer code written to make use of the existing real sparse direct solvers to solve complex, sparse matrix linear equations. PCSMS converts complex matrices into real matrices and use real, sparse direct matrix solvers to factor and solve the real matrices. The solution vector is reconverted to complex numbers. Though, this utility is written for Silicon Graphics (SGI) real sparse matrix solution routines, it is general in nature and can be easily modified to work with any real sparse matrix solver. The User's Manual is written to make the user acquainted with the installation and operation of the code. Driver routines are given to aid the users to integrate PCSMS routines in their own codes.

  8. Elliptic fibrations of maximal rank on a supersingular K3 surface

    International Nuclear Information System (INIS)

    Shioda, Tetsuji

    2013-01-01

    We study a class of elliptic K3 surfaces defined by an explicit Weierstrass equation to find elliptic fibrations of maximal rank on K3 surface in positive characteristic. In particular, we show that the supersingular K3 surface of Artin invariant 1 (unique by Ogus) admits at least one elliptic fibration with maximal rank 20 in every characteristic p>7, p≠13, and further that the number, say N(p), of such elliptic fibrations (up to isomorphisms), is unbounded as p → ∞; in fact, we prove that lim p→∞ N(p)/p 2 ≥(1/12) 2 .

  9. Stochastic Partial Differential Equation Solver for Hydroacoustic Modeling: Improvements to Paracousti Sound Propagation Solver

    Science.gov (United States)

    Preston, L. A.

    2017-12-01

    Marine hydrokinetic (MHK) devices offer a clean, renewable alternative energy source for the future. Responsible utilization of MHK devices, however, requires that the effects of acoustic noise produced by these devices on marine life and marine-related human activities be well understood. Paracousti is a 3-D full waveform acoustic modeling suite that can accurately propagate MHK noise signals in the complex bathymetry found in the near-shore to open ocean environment and considers real properties of the seabed, water column, and air-surface interface. However, this is a deterministic simulation that assumes the environment and source are exactly known. In reality, environmental and source characteristics are often only known in a statistical sense. Thus, to fully characterize the expected noise levels within the marine environment, this uncertainty in environmental and source factors should be incorporated into the acoustic simulations. One method is to use Monte Carlo (MC) techniques where simulation results from a large number of deterministic solutions are aggregated to provide statistical properties of the output signal. However, MC methods can be computationally prohibitive since they can require tens of thousands or more simulations to build up an accurate representation of those statistical properties. An alternative method, using the technique of stochastic partial differential equations (SPDE), allows computation of the statistical properties of output signals at a small fraction of the computational cost of MC. We are developing a SPDE solver for the 3-D acoustic wave propagation problem called Paracousti-UQ to help regulators and operators assess the statistical properties of environmental noise produced by MHK devices. In this presentation, we present the SPDE method and compare statistical distributions of simulated acoustic signals in simple models to MC simulations to show the accuracy and efficiency of the SPDE method. Sandia National Laboratories

  10. A multilevel in space and energy solver for multigroup diffusion eigenvalue problems

    Directory of Open Access Journals (Sweden)

    Ben C. Yee

    2017-09-01

    Full Text Available In this paper, we present a new multilevel in space and energy diffusion (MSED method for solving multigroup diffusion eigenvalue problems. The MSED method can be described as a PI scheme with three additional features: (1 a grey (one-group diffusion equation used to efficiently converge the fission source and eigenvalue, (2 a space-dependent Wielandt shift technique used to reduce the number of PIs required, and (3 a multigrid-in-space linear solver for the linear solves required by each PI step. In MSED, the convergence of the solution of the multigroup diffusion eigenvalue problem is accelerated by performing work on lower-order equations with only one group and/or coarser spatial grids. Results from several Fourier analyses and a one-dimensional test code are provided to verify the efficiency of the MSED method and to justify the incorporation of the grey diffusion equation and the multigrid linear solver. These results highlight the potential efficiency of the MSED method as a solver for multidimensional multigroup diffusion eigenvalue problems, and they serve as a proof of principle for future work. Our ultimate goal is to implement the MSED method as an efficient solver for the two-dimensional/three-dimensional coarse mesh finite difference diffusion system in the Michigan parallel characteristics transport code. The work in this paper represents a necessary step towards that goal.

  11. On the implementation of an accurate and efficient solver for convection-diffusion equations

    Science.gov (United States)

    Wu, Chin-Tien

    In this dissertation, we examine several different aspects of computing the numerical solution of the convection-diffusion equation. The solution of this equation often exhibits sharp gradients due to Dirichlet outflow boundaries or discontinuities in boundary conditions. Because of the singular-perturbed nature of the equation, numerical solutions often have severe oscillations when grid sizes are not small enough to resolve sharp gradients. To overcome such difficulties, the streamline diffusion discretization method can be used to obtain an accurate approximate solution in regions where the solution is smooth. To increase accuracy of the solution in the regions containing layers, adaptive mesh refinement and mesh movement based on a posteriori error estimations can be employed. An error-adapted mesh refinement strategy based on a posteriori error estimations is also proposed to resolve layers. For solving the sparse linear systems that arise from discretization, goemetric multigrid (MG) and algebraic multigrid (AMG) are compared. In addition, both methods are also used as preconditioners for Krylov subspace methods. We derive some convergence results for MG with line Gauss-Seidel smoothers and bilinear interpolation. Finally, while considering adaptive mesh refinement as an integral part of the solution process, it is natural to set a stopping tolerance for the iterative linear solvers on each mesh stage so that the difference between the approximate solution obtained from iterative methods and the finite element solution is bounded by an a posteriori error bound. Here, we present two stopping criteria. The first is based on a residual-type a posteriori error estimator developed by Verfurth. The second is based on an a posteriori error estimator, using local solutions, developed by Kay and Silvester. Our numerical results show the refined mesh obtained from the iterative solution which satisfies the second criteria is similar to the refined mesh obtained from

  12. On the Use of a Direct Radiative Transfer Equation Solver for Path Loss Calculation in Underwater Optical Wireless Channels

    KAUST Repository

    Li, Changping; Park, Kihong; Alouini, Mohamed-Slim

    2015-01-01

    In this letter, we propose a fast numerical solution for the steady state radiative transfer equation based on the approach in [1] in order to calculate the optical path loss of light propagation suffering from attenuation due to the absorption and scattering in various water types. We apply an optimal non-uniform method to discretize the angular space and an upwind type finite difference method to discretize the spatial space. A Gauss-Seidel iterative method is then applied to solve the fully discretized system of linear equations. Finally, we extend the resulting radiance in 2-dimensional to 3-dimensional by the azimuthal symmetric assumption to compute the received optical power under the given receiver aperture and field of view. The accuracy and efficiency of the proposed scheme are validated by uniform RTE solver and Monte Carlo simulations.

  13. On the Use of a Direct Radiative Transfer Equation Solver for Path Loss Calculation in Underwater Optical Wireless Channels

    KAUST Repository

    Li, Changping

    2015-07-22

    In this letter, we propose a fast numerical solution for the steady state radiative transfer equation based on the approach in [1] in order to calculate the optical path loss of light propagation suffering from attenuation due to the absorption and scattering in various water types. We apply an optimal non-uniform method to discretize the angular space and an upwind type finite difference method to discretize the spatial space. A Gauss-Seidel iterative method is then applied to solve the fully discretized system of linear equations. Finally, we extend the resulting radiance in 2-dimensional to 3-dimensional by the azimuthal symmetric assumption to compute the received optical power under the given receiver aperture and field of view. The accuracy and efficiency of the proposed scheme are validated by uniform RTE solver and Monte Carlo simulations.

  14. Numerics made easy: solving the Navier-Stokes equation for arbitrary channel cross-sections using Microsoft Excel.

    Science.gov (United States)

    Richter, Christiane; Kotz, Frederik; Giselbrecht, Stefan; Helmer, Dorothea; Rapp, Bastian E

    2016-06-01

    The fluid mechanics of microfluidics is distinctively simpler than the fluid mechanics of macroscopic systems. In macroscopic systems effects such as non-laminar flow, convection, gravity etc. need to be accounted for all of which can usually be neglected in microfluidic systems. Still, there exists only a very limited selection of channel cross-sections for which the Navier-Stokes equation for pressure-driven Poiseuille flow can be solved analytically. From these equations, velocity profiles as well as flow rates can be calculated. However, whenever a cross-section is not highly symmetric (rectangular, elliptical or circular) the Navier-Stokes equation can usually not be solved analytically. In all of these cases, numerical methods are required. However, in many instances it is not necessary to turn to complex numerical solver packages for deriving, e.g., the velocity profile of a more complex microfluidic channel cross-section. In this paper, a simple spreadsheet analysis tool (here: Microsoft Excel) will be used to implement a simple numerical scheme which allows solving the Navier-Stokes equation for arbitrary channel cross-sections.

  15. A General Symbolic PDE Solver Generator: Explicit Schemes

    Directory of Open Access Journals (Sweden)

    K. Sheshadri

    2003-01-01

    Full Text Available A symbolic solver generator to deal with a system of partial differential equations (PDEs in functions of an arbitrary number of variables is presented; it can also handle arbitrary domains (geometries of the independent variables. Given a system of PDEs, the solver generates a set of explicit finite-difference methods to any specified order, and a Fourier stability criterion for each method. For a method that is stable, an iteration function is generated symbolically using the PDE and its initial and boundary conditions. This iteration function is dynamically generated for every PDE problem, and its evaluation provides a solution to the PDE problem. A C++/Fortran 90 code for the iteration function is generated using the MathCode system, which results in a performance gain of the order of a thousand over Mathematica, the language that has been used to code the solver generator. Examples of stability criteria are presented that agree with known criteria; examples that demonstrate the generality of the solver and the speed enhancement of the generated C++ and Fortran 90 codes are also presented.

  16. MINARET: Towards a time-dependent neutron transport parallel solver

    International Nuclear Information System (INIS)

    Baudron, A.M.; Lautard, J.J.; Maday, Y.; Mula, O.

    2013-01-01

    We present the newly developed time-dependent 3D multigroup discrete ordinates neutron transport solver that has recently been implemented in the MINARET code. The solver is the support for a study about computing acceleration techniques that involve parallel architectures. In this work, we will focus on the parallelization of two of the variables involved in our equation: the angular directions and the time. This last variable has been parallelized by a (time) domain decomposition method called the para-real in time algorithm. (authors)

  17. A transmission line model for propagation in elliptical core optical fibers

    Science.gov (United States)

    Georgantzos, E.; Papageorgiou, C.; Boucouvalas, A. C.

    2015-12-01

    The calculation of mode propagation constants of elliptical core fibers has been the purpose of extended research leading to many notable methods, with the classic step index solution based on Mathieu functions. This paper seeks to derive a new innovative method for the determination of mode propagation constants in single mode fibers with elliptic core by modeling the elliptical fiber as a series of connected coupled transmission line elements. We develop a matrix formulation of the transmission line and the resonance of the circuits is used to calculate the mode propagation constants. The technique, used with success in the case of cylindrical fibers, is now being extended for the case of fibers with elliptical cross section. The advantage of this approach is that it is very well suited to be able to calculate the mode dispersion of arbitrary refractive index profile elliptical waveguides. The analysis begins with the deployment Maxwell's equations adjusted for elliptical coordinates. Further algebraic analysis leads to a set of equations where we are faced with the appearance of harmonics. Taking into consideration predefined fixed number of harmonics simplifies the problem and enables the use of the resonant circuits approach. According to each case, programs have been created in Matlab, providing with a series of results (mode propagation constants) that are further compared with corresponding results from the ready known Mathieu functions method.

  18. A transmission line model for propagation in elliptical core optical fibers

    International Nuclear Information System (INIS)

    Georgantzos, E.; Boucouvalas, A. C.; Papageorgiou, C.

    2015-01-01

    The calculation of mode propagation constants of elliptical core fibers has been the purpose of extended research leading to many notable methods, with the classic step index solution based on Mathieu functions. This paper seeks to derive a new innovative method for the determination of mode propagation constants in single mode fibers with elliptic core by modeling the elliptical fiber as a series of connected coupled transmission line elements. We develop a matrix formulation of the transmission line and the resonance of the circuits is used to calculate the mode propagation constants. The technique, used with success in the case of cylindrical fibers, is now being extended for the case of fibers with elliptical cross section. The advantage of this approach is that it is very well suited to be able to calculate the mode dispersion of arbitrary refractive index profile elliptical waveguides. The analysis begins with the deployment Maxwell’s equations adjusted for elliptical coordinates. Further algebraic analysis leads to a set of equations where we are faced with the appearance of harmonics. Taking into consideration predefined fixed number of harmonics simplifies the problem and enables the use of the resonant circuits approach. According to each case, programs have been created in Matlab, providing with a series of results (mode propagation constants) that are further compared with corresponding results from the ready known Mathieu functions method

  19. Computable Error Estimates for Finite Element Approximations of Elliptic Partial Differential Equations with Rough Stochastic Data

    KAUST Repository

    Hall, Eric Joseph

    2016-12-08

    We derive computable error estimates for finite element approximations of linear elliptic partial differential equations with rough stochastic coefficients. In this setting, the exact solutions contain high frequency content that standard a posteriori error estimates fail to capture. We propose goal-oriented estimates, based on local error indicators, for the pathwise Galerkin and expected quadrature errors committed in standard, continuous, piecewise linear finite element approximations. Derived using easily validated assumptions, these novel estimates can be computed at a relatively low cost and have applications to subsurface flow problems in geophysics where the conductivities are assumed to have lognormal distributions with low regularity. Our theory is supported by numerical experiments on test problems in one and two dimensions.

  20. Clock Gating Based Energy Efficient and Thermal Aware Design for Vedic Equation Solver on 28nm and 40nm FPGA

    DEFF Research Database (Denmark)

    Pandey, Bishwajeet; Pandey, Sujeet; Sharma, Shivani

    2016-01-01

    In this paper, we are integrating clock gating in design of energy efficient equation solver circuits based on Vedic mathematics. Clock gating is one of the best energy efficient techniques. The Sutra 'SunyamSamyasamuccaye' says thatif sum of numerator and sum of denominator is same then we can e......, 94.54% for 1800MHz, and 94.02% for 2.2GHz, when we use gated clock instead of un gated one on 40nm FPGA and temperature is 329.85K. Power consumption in 28nm FPGA is less than 40nm FPGA....

  1. Positive solutions with single and multi-peak for semilinear elliptic ...

    Indian Academy of Sciences (India)

    LI WANG

    2018-04-24

    Apr 24, 2018 ... [2] Bahri A and Lions P, On the existence of a positive solution of semilinear elliptic equations in unbounded domains, Ann. Inst. H. Poincaré Anal. Non Linéaire 14(3) (1997) 365–413. [3] Cao D, and Noussair E, Multiplicity of positive and nodal solutions for nonlinear elliptic problems in RN , Ann. Inst. H.

  2. Integral formula for elliptic SOS models with domain walls and a reflecting end

    Energy Technology Data Exchange (ETDEWEB)

    Lamers, Jules, E-mail: j.lamers@uu.nl

    2015-12-15

    In this paper we extend previous work of Galleas and the author to elliptic SOS models. We demonstrate that the dynamical reflection algebra can be exploited to obtain a functional equation characterizing the partition function of an elliptic SOS model with domain-wall boundaries and one reflecting end. Special attention is paid to the structure of the functional equation. Through this approach we find a novel multiple-integral formula for that partition function.

  3. A solver for General Unilateral Polynomial Matrix Equation with Second-Order Matrices Over Prime Finite Fields

    Science.gov (United States)

    Burtyka, Filipp

    2018-03-01

    The paper firstly considers the problem of finding solvents for arbitrary unilateral polynomial matrix equations with second-order matrices over prime finite fields from the practical point of view: we implement the solver for this problem. The solver’s algorithm has two step: the first is finding solvents, having Jordan Normal Form (JNF), the second is finding solvents among the rest matrices. The first step reduces to the finding roots of usual polynomials over finite fields, the second is essentially exhaustive search. The first step’s algorithms essentially use the polynomial matrices theory. We estimate the practical duration of computations using our software implementation (for example that one can’t construct unilateral matrix polynomial over finite field, having any predefined number of solvents) and answer some theoretically-valued questions.

  4. Ellipticities of Elliptical Galaxies in Different Environments

    Science.gov (United States)

    Chen, Cheng-Yu; Hwang, Chorng-Yuan; Ko, Chung-Ming

    2016-10-01

    We studied the ellipticity distributions of elliptical galaxies in different environments. From the ninth data release of the Sloan Digital Sky Survey, we selected galaxies with absolute {r}\\prime -band magnitudes between -21 and -22. We used the volume number densities of galaxies as the criterion for selecting the environments of the galaxies. Our samples were divided into three groups with different volume number densities. The ellipticity distributions of the elliptical galaxies differed considerably in these three groups of different density regions. We deprojected the observed 2D ellipticity distributions into intrinsic 3D shape distributions, and the result showed that the shapes of the elliptical galaxies were relatively spherically symmetric in the high density region (HDR) and that relatively more flat galaxies were present in the low density region (LDR). This suggests that the ellipticals in the HDRs and LDRs have different origins or that different mechanisms might be involved. The elliptical galaxies in the LDR are likely to have evolved from mergers in relatively anisotropic structures, such as filaments and webs, and might contain information on the anisotropic spatial distribution of their parent mergers. By contrast, elliptical galaxies in the HDR might be formed in more isotropic structures, such as galaxy clusters, or they might encounter more torqueing effects compared with galaxies in LDRs, thereby becoming rounder.

  5. Electric sail elliptic displaced orbits with advanced thrust model

    Science.gov (United States)

    Niccolai, Lorenzo; Quarta, Alessandro A.; Mengali, Giovanni

    2017-09-01

    This paper analyzes the performance of an Electric Solar Wind Sail for generating and maintaining an elliptic, heliocentric, displaced non-Keplerian orbit. In this sense, this paper extends and completes recent studies regarding the performances of an Electric Solar Wind Sail that covers a circular, heliocentric, displaced orbit of given characteristics. The paper presents the general equations that describe the elliptic orbit maintenance in terms of both spacecraft attitude and performance requirements, when a refined thrust model (recently proposed for the preliminary mission design) is taken into account. In particular, the paper also discusses some practical applications on particular mission scenarios in which an analytic solution of the governing equations has been found.

  6. A GPU accelerated and error-controlled solver for the unbounded Poisson equation in three dimensions

    Science.gov (United States)

    Exl, Lukas

    2017-12-01

    An efficient solver for the three dimensional free-space Poisson equation is presented. The underlying numerical method is based on finite Fourier series approximation. While the error of all involved approximations can be fully controlled, the overall computation error is driven by the convergence of the finite Fourier series of the density. For smooth and fast-decaying densities the proposed method will be spectrally accurate. The method scales with O(N log N) operations, where N is the total number of discretization points in the Cartesian grid. The majority of the computational costs come from fast Fourier transforms (FFT), which makes it ideal for GPU computation. Several numerical computations on CPU and GPU validate the method and show efficiency and convergence behavior. Tests are performed using the Vienna Scientific Cluster 3 (VSC3). A free MATLAB implementation for CPU and GPU is provided to the interested community.

  7. Regularity theory for quasilinear elliptic systems and Monge—Ampère equations in two dimensions

    CERN Document Server

    Schulz, Friedmar

    1990-01-01

    These lecture notes have been written as an introduction to the characteristic theory for two-dimensional Monge-Ampère equations, a theory largely developed by H. Lewy and E. Heinz which has never been presented in book form. An exposition of the Heinz-Lewy theory requires auxiliary material which can be found in various monographs, but which is presented here, in part because the focus is different, and also because these notes have an introductory character. Self-contained introductions to the regularity theory of elliptic systems, the theory of pseudoanalytic functions and the theory of conformal mappings are included. These notes grew out of a seminar given at the University of Kentucky in the fall of 1988 and are intended for graduate students and researchers interested in this area.

  8. Type A Jacobi Elliptic One-Monopole

    International Nuclear Information System (INIS)

    Teh, Rosy; Wong, Khai-Ming

    2010-01-01

    We present new classical generalized one-monopole solution of the SU(2) Yang-Mills-Higgs theory with the Higgs field in the adjoint representation. We show that this generalized solution with Θ-winding number m = 1 and φ-winding number n = 1 is an axially symmetric Jacobi elliptic generalization of the 't Hooft-Polyakov one-monopole. We construct this axially symmetric one-monopole solution by generalizing the large distance asymptotic solution of the 't Hooft-Polyakov one-monopole to the Jacobi elliptic functions and solving the second order equations of motion numerically when the Higgs potential is vanishing. This solution is a regular non-BPS finite energy solution.

  9. ON ELLIPTICALLY POLARIZED ANTENNAS IN THE PRESENCE OF GROUND

    Science.gov (United States)

    The effect of ground reflections upon the far field of an elliptically polarized antenna of ar itrary orientation with r spect to ground is...investigated. The equation of the polarization ellipse produced by an elliptically polarized antenna in the presence of ground is derived, AND SEVERAL...EXAMPLES ILLUSTRATE THE VARIATION IN THE AXIS RATIO OF THE POLARIZATION ELLIPSE AS A FUNCTION OF THE GEOMETRY OF THE MEASURING SETUP. A method is presented

  10. A note on Chudnovskyʼs Fuchsian equations

    Science.gov (United States)

    Brezhnev, Yurii V.

    We show that four exceptional Fuchsian equations, each determined by the four parabolic singularities, known as the Chudnovsky equations, are transformed into each other by algebraic transformations. We describe equivalence of these equations and their counterparts on tori. The latters are the Fuchsian equations on elliptic curves and their equivalence is characterized by transcendental transformations which are represented explicitly in terms of elliptic and theta functions.

  11. A GPU-based incompressible Navier-Stokes solver on moving overset grids

    Science.gov (United States)

    Chandar, Dominic D. J.; Sitaraman, Jayanarayanan; Mavriplis, Dimitri J.

    2013-07-01

    In pursuit of obtaining high fidelity solutions to the fluid flow equations in a short span of time, graphics processing units (GPUs) which were originally intended for gaming applications are currently being used to accelerate computational fluid dynamics (CFD) codes. With a high peak throughput of about 1 TFLOPS on a PC, GPUs seem to be favourable for many high-resolution computations. One such computation that involves a lot of number crunching is computing time accurate flow solutions past moving bodies. The aim of the present paper is thus to discuss the development of a flow solver on unstructured and overset grids and its implementation on GPUs. In its present form, the flow solver solves the incompressible fluid flow equations on unstructured/hybrid/overset grids using a fully implicit projection method. The resulting discretised equations are solved using a matrix-free Krylov solver using several GPU kernels such as gradient, Laplacian and reduction. Some of the simple arithmetic vector calculations are implemented using the CU++: An Object Oriented Framework for Computational Fluid Dynamics Applications using Graphics Processing Units, Journal of Supercomputing, 2013, doi:10.1007/s11227-013-0985-9 approach where GPU kernels are automatically generated at compile time. Results are presented for two- and three-dimensional computations on static and moving grids.

  12. Improved integrability of the gradients of solutions of elliptic equations with variable nonlinearity exponent

    International Nuclear Information System (INIS)

    Zhikov, Vasilii V; Pastukhova, Svetlana E

    2008-01-01

    Elliptic equations of p(x)-Laplacian type are investigated. There is a well-known logarithmic condition on the modulus of continuity of the nonlinearity exponent p(x), which ensures that a Laplacian with variable order of nonlinearity inherits many properties of the usual p-Laplacian of constant order. One of these is the so-called improved integrability of the gradient of the solution. It is proved in this paper that this property holds also under a slightly more general condition on the exponent p(x), although then the improvement of integrability is logarithmic rather than power-like. The method put forward is based on a new generalization of Gehring's lemma, which relies upon the reverse Hoelder inequality 'with increased support and exponent on the right-hand side'. A counterexample is constructed that reveals the extent to which the condition on the modulus of continuity obtained is sharp. Bibliography: 28 titles.

  13. Experimental validation of a boundary element solver for exterior acoustic radiation problems

    NARCIS (Netherlands)

    Visser, Rene; Nilsson, A.; Boden, H.

    2003-01-01

    The relation between harmonic structural vibrations and the corresponding acoustic radiation is given by the Helmholtz integral equation (HIE). To solve this integral equation a new solver (BEMSYS) based on the boundary element method (BEM) has been implemented. This numerical tool can be used for

  14. Design of an elliptical solenoid magnet for transverse beam matching to the spiral inflector

    International Nuclear Information System (INIS)

    Goswami, A.; Sing Babu, P.; Pandit, V.S.

    2013-01-01

    In this work, we present the design study of an elliptical solenoid magnet to be used for transverse beam matching at the input of a spiral inflector for efficient transmission. We have studied the dependence of axial field and gradients in the transverse directions of the elliptical solenoid magnet with ellipticity of the aperture. Using the beam envelope equations we have studied the feasibility of using an elliptical solenoid for transverse beam matching to the acceptance of a spiral inflector. (author)

  15. Domain decomposition based iterative methods for nonlinear elliptic finite element problems

    Energy Technology Data Exchange (ETDEWEB)

    Cai, X.C. [Univ. of Colorado, Boulder, CO (United States)

    1994-12-31

    The class of overlapping Schwarz algorithms has been extensively studied for linear elliptic finite element problems. In this presentation, the author considers the solution of systems of nonlinear algebraic equations arising from the finite element discretization of some nonlinear elliptic equations. Several overlapping Schwarz algorithms, including the additive and multiplicative versions, with inexact Newton acceleration will be discussed. The author shows that the convergence rate of the Newton`s method is independent of the mesh size used in the finite element discretization, and also independent of the number of subdomains into which the original domain in decomposed. Numerical examples will be presented.

  16. Numerical Solution of Time-Dependent Problems with a Fractional-Power Elliptic Operator

    Science.gov (United States)

    Vabishchevich, P. N.

    2018-03-01

    A time-dependent problem in a bounded domain for a fractional diffusion equation is considered. The first-order evolution equation involves a fractional-power second-order elliptic operator with Robin boundary conditions. A finite-element spatial approximation with an additive approximation of the operator of the problem is used. The time approximation is based on a vector scheme. The transition to a new time level is ensured by solving a sequence of standard elliptic boundary value problems. Numerical results obtained for a two-dimensional model problem are presented.

  17. Strongly coupled partitioned six degree-of-freedom rigid body motion solver with Aitken's dynamic under-relaxation

    Directory of Open Access Journals (Sweden)

    Jeng Hei Chow

    2016-07-01

    Full Text Available An implicit method of solving the six degree-of-freedom rigid body motion equations based on the second order Adams-Bashforth-Moulten method was utilised as an improvement over the leapfrog scheme by making modifications to the rigid body motion solver libraries directly. The implementation will depend on predictor-corrector steps still residing within the hybrid Pressure Implicit with Splitting of Operators - Semi-Implicit Method for Pressure Linked Equations (PIMPLE outer corrector loops to ensure strong coupling between fluid and motion. Aitken's under-relaxation is also introduced in this study to optimise the convergence rate and stability of the coupled solver. The resulting coupled solver ran on a free floating object tutorial test case when converged matches the original solver. It further allows a varying 70%–80% reduction in simulation times compared using a fixed under-relaxation to achieve the required stability.

  18. The modified extended Fan's sub-equation method and its application to (2 + 1)-dimensional dispersive long wave equation

    International Nuclear Information System (INIS)

    Yomba, Emmanuel

    2005-01-01

    By using a modified extended Fan's sub-equation method, we have obtained new and more general solutions including a series of non-travelling wave and coefficient function solutions namely: soliton-like solutions, triangular-like solutions, single and combined non-degenerative Jacobi elliptic wave function-like solutions for the (2 + 1)-dimensional dispersive long wave equation. The most important achievement of this method lies on the fact that, we have succeeded in one move to give all the solutions which can be previously obtained by application of at least four methods (method using Riccati equation, or first kind elliptic equation, or auxiliary ordinary equation, or generalized Riccati equation as mapping equation)

  19. GPU-Accelerated Sparse Matrix Solvers for Large-Scale Simulations, Phase II

    Data.gov (United States)

    National Aeronautics and Space Administration — At the heart of scientific computing and numerical analysis are linear algebra solvers. In scientific computing, the focus is on the partial differential equations...

  20. A Nonlinear Modal Aeroelastic Solver for FUN3D

    Science.gov (United States)

    Goldman, Benjamin D.; Bartels, Robert E.; Biedron, Robert T.; Scott, Robert C.

    2016-01-01

    A nonlinear structural solver has been implemented internally within the NASA FUN3D computational fluid dynamics code, allowing for some new aeroelastic capabilities. Using a modal representation of the structure, a set of differential or differential-algebraic equations are derived for general thin structures with geometric nonlinearities. ODEPACK and LAPACK routines are linked with FUN3D, and the nonlinear equations are solved at each CFD time step. The existing predictor-corrector method is retained, whereby the structural solution is updated after mesh deformation. The nonlinear solver is validated using a test case for a flexible aeroshell at transonic, supersonic, and hypersonic flow conditions. Agreement with linear theory is seen for the static aeroelastic solutions at relatively low dynamic pressures, but structural nonlinearities limit deformation amplitudes at high dynamic pressures. No flutter was found at any of the tested trajectory points, though LCO may be possible in the transonic regime.

  1. Doubly periodic solutions of the modified Kawahara equation

    International Nuclear Information System (INIS)

    Zhang Dan

    2005-01-01

    Some doubly periodic (Jacobi elliptic function) solutions of the modified Kawahara equation are presented in closed form. Our approach is to introduce a new auxiliary ordinary differential equation and use its Jacobi elliptic function solutions to construct doubly periodic solutions of the modified Kawahara equation. When the module m → 1, these solutions degenerate to the exact solitary wave solutions of the equation. Then we reveal the relation of some exact solutions for the modified Kawahara equation obtained by other authors

  2. Partial Differential Equations

    CERN Document Server

    1988-01-01

    The volume contains a selection of papers presented at the 7th Symposium on differential geometry and differential equations (DD7) held at the Nankai Institute of Mathematics, Tianjin, China, in 1986. Most of the contributions are original research papers on topics including elliptic equations, hyperbolic equations, evolution equations, non-linear equations from differential geometry and mechanics, micro-local analysis.

  3. Modeling and analysis of waves in a heat conducting thermo-elastic plate of elliptical shape

    Directory of Open Access Journals (Sweden)

    R. Selvamani

    Full Text Available Wave propagation in heat conducting thermo elastic plate of elliptical cross-section is studied using the Fourier expansion collocation method based on Suhubi's generalized theory. The equations of motion based on two-dimensional theory of elasticity is applied under the plane strain assumption of generalized thermo elastic plate of elliptical cross-sections composed of homogeneous isotropic material. The frequency equations are obtained by using the boundary conditions along outer and inner surface of elliptical cross-sectional plate using Fourier expansion collocation method. The computed non-dimensional frequency, velocity and quality factor are plotted in dispersion curves for longitudinal and flexural (symmetric and antisymmetric modes of vibrations.

  4. Generalized conjugate-gradient methods for the Navier-Stokes equations

    Science.gov (United States)

    Ajmani, Kumud; Ng, Wing-Fai; Liou, Meng-Sing

    1991-01-01

    A generalized conjugate-gradient method is used to solve the two-dimensional, compressible Navier-Stokes equations of fluid flow. The equations are discretized with an implicit, upwind finite-volume formulation. Preconditioning techniques are incorporated into the new solver to accelerate convergence of the overall iterative method. The superiority of the new solver is demonstrated by comparisons with a conventional line Gauss-Siedel Relaxation solver. Computational test results for transonic flow (trailing edge flow in a transonic turbine cascade) and hypersonic flow (M = 6.0 shock-on-shock phenoena on a cylindrical leading edge) are presented. When applied to the transonic cascade case, the new solver is 4.4 times faster in terms of number of iterations and 3.1 times faster in terms of CPU time than the Relaxation solver. For the hypersonic shock case, the new solver is 3.0 times faster in terms of number of iterations and 2.2 times faster in terms of CPU time than the Relaxation solver.

  5. A heterogeneous stochastic FEM framework for elliptic PDEs

    International Nuclear Information System (INIS)

    Hou, Thomas Y.; Liu, Pengfei

    2015-01-01

    We introduce a new concept of sparsity for the stochastic elliptic operator −div(a(x,ω)∇(⋅)), which reflects the compactness of its inverse operator in the stochastic direction and allows for spatially heterogeneous stochastic structure. This new concept of sparsity motivates a heterogeneous stochastic finite element method (HSFEM) framework for linear elliptic equations, which discretizes the equations using the heterogeneous coupling of spatial basis with local stochastic basis to exploit the local stochastic structure of the solution space. We also provide a sampling method to construct the local stochastic basis for this framework using the randomized range finding techniques. The resulting HSFEM involves two stages and suits the multi-query setting: in the offline stage, the local stochastic structure of the solution space is identified; in the online stage, the equation can be efficiently solved for multiple forcing functions. An online error estimation and correction procedure through Monte Carlo sampling is given. Numerical results for several problems with high dimensional stochastic input are presented to demonstrate the efficiency of the HSFEM in the online stage

  6. Classification of exact solutions to the generalized Kadomtsev-Petviashvili equation

    International Nuclear Information System (INIS)

    Pandir, Yusuf; Gurefe, Yusuf; Misirli, Emine

    2013-01-01

    In this paper, we study the Kadomtsev-Petviashvili equation with generalized evolution and derive some new results using the approach called the trial equation method. The obtained results can be expressed by the soliton solutions, rational function solutions, elliptic function solutions and Jacobi elliptic function solutions. In the discussion, we give a new version of the trial equation method for nonlinear differential equations.

  7. Fast Laplace solver approach to pore-scale permeability

    Science.gov (United States)

    Arns, C. H.; Adler, P. M.

    2018-02-01

    We introduce a powerful and easily implemented method to calculate the permeability of porous media at the pore scale using an approximation based on the Poiseulle equation to calculate permeability to fluid flow with a Laplace solver. The method consists of calculating the Euclidean distance map of the fluid phase to assign local conductivities and lends itself naturally to the treatment of multiscale problems. We compare with analytical solutions as well as experimental measurements and lattice Boltzmann calculations of permeability for Fontainebleau sandstone. The solver is significantly more stable than the lattice Boltzmann approach, uses less memory, and is significantly faster. Permeabilities are in excellent agreement over a wide range of porosities.

  8. Numerical Analysis of Partial Differential Equations

    CERN Document Server

    Lui, S H

    2011-01-01

    A balanced guide to the essential techniques for solving elliptic partial differential equations Numerical Analysis of Partial Differential Equations provides a comprehensive, self-contained treatment of the quantitative methods used to solve elliptic partial differential equations (PDEs), with a focus on the efficiency as well as the error of the presented methods. The author utilizes coverage of theoretical PDEs, along with the nu merical solution of linear systems and various examples and exercises, to supply readers with an introduction to the essential concepts in the numerical analysis

  9. Solving the Fluid Pressure Poisson Equation Using Multigrid-Evaluation and Improvements.

    Science.gov (United States)

    Dick, Christian; Rogowsky, Marcus; Westermann, Rudiger

    2016-11-01

    In many numerical simulations of fluids governed by the incompressible Navier-Stokes equations, the pressure Poisson equation needs to be solved to enforce mass conservation. Multigrid solvers show excellent convergence in simple scenarios, yet they can converge slowly in domains where physically separated regions are combined at coarser scales. Moreover, existing multigrid solvers are tailored to specific discretizations of the pressure Poisson equation, and they cannot easily be adapted to other discretizations. In this paper we analyze the convergence properties of existing multigrid solvers for the pressure Poisson equation in different simulation domains, and we show how to further improve the multigrid convergence rate by using a graph-based extension to determine the coarse grid hierarchy. The proposed multigrid solver is generic in that it can be applied to different kinds of discretizations of the pressure Poisson equation, by using solely the specification of the simulation domain and pre-assembled computational stencils. We analyze the proposed solver in combination with finite difference and finite volume discretizations of the pressure Poisson equation. Our evaluations show that, despite the common assumption, multigrid schemes can exploit their potential even in the most complicated simulation scenarios, yet this behavior is obtained at the price of higher memory consumption.

  10. A scalable geometric multigrid solver for nonsymmetric elliptic systems with application to variable-density flows

    Science.gov (United States)

    Esmaily, M.; Jofre, L.; Mani, A.; Iaccarino, G.

    2018-03-01

    A geometric multigrid algorithm is introduced for solving nonsymmetric linear systems resulting from the discretization of the variable density Navier-Stokes equations on nonuniform structured rectilinear grids and high-Reynolds number flows. The restriction operation is defined such that the resulting system on the coarser grids is symmetric, thereby allowing for the use of efficient smoother algorithms. To achieve an optimal rate of convergence, the sequence of interpolation and restriction operations are determined through a dynamic procedure. A parallel partitioning strategy is introduced to minimize communication while maintaining the load balance between all processors. To test the proposed algorithm, we consider two cases: 1) homogeneous isotropic turbulence discretized on uniform grids and 2) turbulent duct flow discretized on stretched grids. Testing the algorithm on systems with up to a billion unknowns shows that the cost varies linearly with the number of unknowns. This O (N) behavior confirms the robustness of the proposed multigrid method regarding ill-conditioning of large systems characteristic of multiscale high-Reynolds number turbulent flows. The robustness of our method to density variations is established by considering cases where density varies sharply in space by a factor of up to 104, showing its applicability to two-phase flow problems. Strong and weak scalability studies are carried out, employing up to 30,000 processors, to examine the parallel performance of our implementation. Excellent scalability of our solver is shown for a granularity as low as 104 to 105 unknowns per processor. At its tested peak throughput, it solves approximately 4 billion unknowns per second employing over 16,000 processors with a parallel efficiency higher than 50%.

  11. Efficiency optimization of a fast Poisson solver in beam dynamics simulation

    Science.gov (United States)

    Zheng, Dawei; Pöplau, Gisela; van Rienen, Ursula

    2016-01-01

    Calculating the solution of Poisson's equation relating to space charge force is still the major time consumption in beam dynamics simulations and calls for further improvement. In this paper, we summarize a classical fast Poisson solver in beam dynamics simulations: the integrated Green's function method. We introduce three optimization steps of the classical Poisson solver routine: using the reduced integrated Green's function instead of the integrated Green's function; using the discrete cosine transform instead of discrete Fourier transform for the Green's function; using a novel fast convolution routine instead of an explicitly zero-padded convolution. The new Poisson solver routine preserves the advantages of fast computation and high accuracy. This provides a fast routine for high performance calculation of the space charge effect in accelerators.

  12. Asynchronous Parallelization of a CFD Solver

    OpenAIRE

    Abdi, Daniel S.; Bitsuamlak, Girma T.

    2015-01-01

    The article of record as published may be found at http://dx.doi.org/10.1155/2015/295393 A Navier-Stokes equations solver is parallelized to run on a cluster of computers using the domain decomposition method. Two approaches of communication and computation are investigated, namely, synchronous and asynchronous methods. Asynchronous communication between subdomains is not commonly used inCFDcodes; however, it has a potential to alleviate scaling bottlenecks incurred due to process...

  13. An approximate factorization procedure for solving nine-point elliptic difference equations. Application for a fast 2-D relativistic Fokker-Planck solver

    Energy Technology Data Exchange (ETDEWEB)

    Peysson, Y. [Association Euratom-CEA, CEA Grenoble, 38 (France). Dept. de Recherches sur la Fusion Controlee; Choucri, M. [Centre Canadien de Fusion Magnetique, Varennes, PQ (Canada)

    1997-09-01

    A full implicit numerical procedure based on the use of a nine-point difference operator is presented to solve the two dimensional (2{sub D}) relativistic Fokker-Planck equation for the current drive problem and synergetic effects between the lower hybrid and the electron cyclotron waves in tokamaks. As compared to the standard approach based on the use of a five-point difference operator [M. Shoucri, I. Shkarofsky, Comput. Phys. Comm. 82 (1994) 287], the convergence rate towards the steady state solution may be significantly enhanced with no loss of accuracy on the distribution function. Moreover, it is shown that the numerical stability may be strongly improved without a large degradation of the CPU time consumption as in the five-point scheme, making this approach very attractive for a fast solution of the 2-D Fokker-Planck equation on a fine grid in conjunction with other numerical codes for realistic plasma simulations. This new algorithm, based on an approximate matrix factorization technique, may be applied to all numerical problems with large sets of equations which involve nine-point difference operators. (author) 21 refs.

  14. An approximate factorization procedure for solving nine-point elliptic difference equations. Application for a fast 2-D relativistic Fokker-Planck solver

    International Nuclear Information System (INIS)

    Peysson, Y.

    1997-09-01

    A full implicit numerical procedure based on the use of a nine-point difference operator is presented to solve the two dimensional (2 D ) relativistic Fokker-Planck equation for the current drive problem and synergetic effects between the lower hybrid and the electron cyclotron waves in tokamaks. As compared to the standard approach based on the use of a five-point difference operator [M. Shoucri, I. Shkarofsky, Comput. Phys. Comm. 82 (1994) 287], the convergence rate towards the steady state solution may be significantly enhanced with no loss of accuracy on the distribution function. Moreover, it is shown that the numerical stability may be strongly improved without a large degradation of the CPU time consumption as in the five-point scheme, making this approach very attractive for a fast solution of the 2-D Fokker-Planck equation on a fine grid in conjunction with other numerical codes for realistic plasma simulations. This new algorithm, based on an approximate matrix factorization technique, may be applied to all numerical problems with large sets of equations which involve nine-point difference operators. (author)

  15. A heterogeneous CPU+GPU Poisson solver for space charge calculations in beam dynamics studies

    Energy Technology Data Exchange (ETDEWEB)

    Zheng, Dawei; Rienen, Ursula van [University of Rostock, Institute of General Electrical Engineering (Germany)

    2016-07-01

    In beam dynamics studies in accelerator physics, space charge plays a central role in the low energy regime of an accelerator. Numerical space charge calculations are required, both, in the design phase and in the operation of the machines as well. Due to its efficiency, mostly the Particle-In-Cell (PIC) method is chosen for the space charge calculation. Then, the solution of Poisson's equation for the charge distribution in the rest frame is the most prominent part within the solution process. The Poisson solver directly affects the accuracy of the self-field applied on the charged particles when the equation of motion is solved in the laboratory frame. As the Poisson solver consumes the major part of the computing time in most simulations it has to be as fast as possible since it has to be carried out once per time step. In this work, we demonstrate a novel heterogeneous CPU+GPU routine for the Poisson solver. The novel solver also benefits from our new research results on the utilization of a discrete cosine transform within the classical Hockney and Eastwood's convolution routine.

  16. Lectures on partial differential equations

    CERN Document Server

    Petrovsky, I G

    1992-01-01

    Graduate-level exposition by noted Russian mathematician offers rigorous, transparent, highly readable coverage of classification of equations, hyperbolic equations, elliptic equations and parabolic equations. Wealth of commentary and insight invaluable for deepening understanding of problems considered in text. Translated from the Russian by A. Shenitzer.

  17. The cost of continuity: A study of the performance of isogeometric finite elements using direct solvers

    KAUST Repository

    Collier, Nathan

    2012-03-01

    We study the performance of direct solvers on linear systems of equations resulting from isogeometric analysis. The problem of choice is the canonical Laplace equation in three dimensions. From this study we conclude that for a fixed number of unknowns and polynomial degree of approximation, a higher degree of continuity k drastically increases the CPU time and RAM needed to solve the problem when using a direct solver. This paper presents numerical results detailing the phenomenon as well as a theoretical analysis that explains the underlying cause. © 2011 Elsevier B.V.

  18. The cost of continuity: A study of the performance of isogeometric finite elements using direct solvers

    KAUST Repository

    Collier, Nathan; Pardo, David; Dalcí n, Lisandro D.; Paszyński, Maciej R.; Calo, Victor M.

    2012-01-01

    We study the performance of direct solvers on linear systems of equations resulting from isogeometric analysis. The problem of choice is the canonical Laplace equation in three dimensions. From this study we conclude that for a fixed number of unknowns and polynomial degree of approximation, a higher degree of continuity k drastically increases the CPU time and RAM needed to solve the problem when using a direct solver. This paper presents numerical results detailing the phenomenon as well as a theoretical analysis that explains the underlying cause. © 2011 Elsevier B.V.

  19. Existence and multiplicity of solutions for divergence type elliptic equations

    Directory of Open Access Journals (Sweden)

    Lin Zhao

    2011-03-01

    Full Text Available We establish the existence and multiplicity of weak solutions of a problem involving a uniformly convex elliptic operator in divergence form. We find one nontrivial solution by the mountain pass lemma, when the nonlinearity has a $(p-1$-superlinear growth at infinity, and two nontrivial solutions by minimization and mountain pass when the nonlinear term has a $(p-1$-sublinear growth at infinity.

  20. Stochastic Differential Equations and Kondratiev Spaces

    Energy Technology Data Exchange (ETDEWEB)

    Vaage, G.

    1995-05-01

    The purpose of this mathematical thesis was to improve the understanding of physical processes such as fluid flow in porous media. An example is oil flowing in a reservoir. In the first of five included papers, Hilbert space methods for elliptic boundary value problems are used to prove the existence and uniqueness of a large family of elliptic differential equations with additive noise without using the Hermite transform. The ideas are then extended to the multidimensional case and used to prove existence and uniqueness of solution of the Stokes equations with additive noise. The second paper uses functional analytic methods for partial differential equations and presents a general framework for proving existence and uniqueness of solutions to stochastic partial differential equations with multiplicative noise, for a large family of noises. The methods are applied to equations of elliptic, parabolic as well as hyperbolic type. The framework presented can be extended to the multidimensional case. The third paper shows how the ideas from the second paper can be extended to study the moving boundary value problem associated with the stochastic pressure equation. The fourth paper discusses a set of stochastic differential equations. The fifth paper studies the relationship between the two families of Kondratiev spaces used in the thesis. 102 refs.

  1. RBF Multiscale Collocation for Second Order Elliptic Boundary Value Problems

    KAUST Repository

    Farrell, Patricio; Wendland, Holger

    2013-01-01

    In this paper, we discuss multiscale radial basis function collocation methods for solving elliptic partial differential equations on bounded domains. The approximate solution is constructed in a multilevel fashion, each level using compactly

  2. A Stochastic Collocation Method for Elliptic Partial Differential Equations with Random Input Data

    KAUST Repository

    Babuška, Ivo; Nobile, Fabio; Tempone, Raul

    2010-01-01

    This work proposes and analyzes a stochastic collocation method for solving elliptic partial differential equations with random coefficients and forcing terms. These input data are assumed to depend on a finite number of random variables. The method consists of a Galerkin approximation in space and a collocation in the zeros of suitable tensor product orthogonal polynomials (Gauss points) in the probability space, and naturally leads to the solution of uncoupled deterministic problems as in the Monte Carlo approach. It treats easily a wide range of situations, such as input data that depend nonlinearly on the random variables, diffusivity coefficients with unbounded second moments, and random variables that are correlated or even unbounded. We provide a rigorous convergence analysis and demonstrate exponential convergence of the “probability error” with respect to the number of Gauss points in each direction of the probability space, under some regularity assumptions on the random input data. Numerical examples show the effectiveness of the method. Finally, we include a section with developments posterior to the original publication of this work. There we review sparse grid stochastic collocation methods, which are effective collocation strategies for problems that depend on a moderately large number of random variables.

  3. Vortex precession in thin elliptical ferromagnetic nanodisks

    Energy Technology Data Exchange (ETDEWEB)

    Zaspel, C.E., E-mail: craig.zaspel@umwestern.edu

    2017-07-01

    Highlights: • A general form for the magnetostatic energy is calculated for the vortex state in a ferromagnetic ellipse. • The ellipse magnetostatic energy is minimized by conformal mapping the circular disk onto the ellipse. • The gyrotropic precession frequency is obtained in general for a range of ellipticities. - Abstract: The magnetostatic energy is calculated for a magnetic vortex in a noncircular elliptical nanodisk. It is well-known that the energy of a vortex in the circular disk is minimized though an ansatz that eliminates the magnetostatic charge at the disk edge. Beginning with this ansatz for the circular disk, a conformal mapping of a circle interior onto the interior of an ellipse results in the magnetization of the elliptical disk. This magnetization in the interior of an ellipse also has no magnetostatic charge at the disk edge also minimizing the magnetostatic energy. As expected the energy has a quadratic dependence on the displacement of the vortex core from the ellipse center, but reflecting the lower symmetry of the ellipse. Through numerical integration of the magnetostatic integral a general expression for the energy is obtained for ellipticity values from 1.0 to about 0.3. Finally a general expression for the gyrotropic frequency as described by the Thiele equation is obtained.

  4. PCX, Interior-Point Linear Programming Solver

    International Nuclear Information System (INIS)

    Czyzyk, J.

    2004-01-01

    1 - Description of program or function: PCX solves linear programming problems using the Mehrota predictor-corrector interior-point algorithm. PCX can be called as a subroutine or used in stand-alone mode, with data supplied from an MPS file. The software incorporates modules that can be used separately from the linear programming solver, including a pre-solve routine and data structure definitions. 2 - Methods: The Mehrota predictor-corrector method is a primal-dual interior-point method for linear programming. The starting point is determined from a modified least squares heuristic. Linear systems of equations are solved at each interior-point iteration via a sparse Cholesky algorithm native to the code. A pre-solver is incorporated in the code to eliminate inefficiencies in the user's formulation of the problem. 3 - Restriction on the complexity of the problem: There are no size limitations built into the program. The size of problem solved is limited by RAM and swap space on the user's computer

  5. Solution of the two dimensional diffusion and transport equations in a rectangular lattice with an elliptical fuel element using Fourier transform methods: One and two group cases

    International Nuclear Information System (INIS)

    Williams, M.M.R.; Hall, S.K.; Eaton, M.D.

    2014-01-01

    Highlights: • A rectangular reactor cell with an elliptical fuel element. • Solution of transport and diffusion equations by Fourier expansion. • Numerical examples showing convergence. • Two group cell problems. - Abstract: A method for solving the diffusion and transport equations in a rectangular lattice cell with an elliptical fuel element has been developed using a Fourier expansion of the neutron flux. The method is applied to a one group model with a source in the moderator. The cell flux is obtained and also the associated disadvantage factor. In addition to the one speed case, we also consider the two group equations in the cell which now become an eigenvalue problem for the lattice multiplication factor. The method of solution relies upon an efficient procedure to solve a large set of simultaneous linear equations and for this we use the IMSL library routines. Our method is compared with the results from a finite element code. The main drawback of the problem arises from the very large number of terms required in the Fourier series which taxes the storage and speed of the computer. Nevertheless, useful solutions are obtained in geometries that would normally require the use of finite element or analogous methods, for this reason the Fourier method is useful for comparison with that type of numerical approach. Extension of the method to more intricate fuel shapes, such as stars and cruciforms as well as superpositions of these, is possible

  6. A physico-mathematical analysis of elliptical nerve and muscle fibres

    International Nuclear Information System (INIS)

    Bonsignori, F.

    1977-01-01

    In the framework of the tridimensional core conductor model, the current flow field of an elliptical nerve or muscle fibre in a volume conductor is studied. As the quasi-static conditions are valid, the Laplace equation applies. Expressions for the intracellular and extra cellular potential fields and the membrane current are exactly derived. As a limit the solutions for the circular case are recovered. Finally a sketch of an approximate method of calculation is outlined and the first elliptical correction to the usual membrane current is evaluated

  7. Minaret, a deterministic neutron transport solver for nuclear core calculations

    Energy Technology Data Exchange (ETDEWEB)

    Moller, J-Y.; Lautard, J-J., E-mail: jean-yves.moller@cea.fr, E-mail: jean-jacques.lautard@cea.fr [CEA - Centre de Saclay , Gif sur Yvette (France)

    2011-07-01

    We present here MINARET a deterministic transport solver for nuclear core calculations to solve the steady state Boltzmann equation. The code follows the multi-group formalism to discretize the energy variable. It uses discrete ordinate method to deal with the angular variable and a DGFEM to solve spatially the Boltzmann equation. The mesh is unstructured in 2D and semi-unstructured in 3D (cylindrical). Curved triangles can be used to fit the exact geometry. For the curved elements, two different sets of basis functions can be used. Transport solver is accelerated with a DSA method. Diffusion and SPN calculations are made possible by skipping the transport sweep in the source iteration. The transport calculations are parallelized with respect to the angular directions. Numerical results are presented for simple geometries and for the C5G7 Benchmark, JHR reactor and the ESFR (in 2D and 3D). Straight and curved finite element results are compared. (author)

  8. Minaret, a deterministic neutron transport solver for nuclear core calculations

    International Nuclear Information System (INIS)

    Moller, J-Y.; Lautard, J-J.

    2011-01-01

    We present here MINARET a deterministic transport solver for nuclear core calculations to solve the steady state Boltzmann equation. The code follows the multi-group formalism to discretize the energy variable. It uses discrete ordinate method to deal with the angular variable and a DGFEM to solve spatially the Boltzmann equation. The mesh is unstructured in 2D and semi-unstructured in 3D (cylindrical). Curved triangles can be used to fit the exact geometry. For the curved elements, two different sets of basis functions can be used. Transport solver is accelerated with a DSA method. Diffusion and SPN calculations are made possible by skipping the transport sweep in the source iteration. The transport calculations are parallelized with respect to the angular directions. Numerical results are presented for simple geometries and for the C5G7 Benchmark, JHR reactor and the ESFR (in 2D and 3D). Straight and curved finite element results are compared. (author)

  9. An iterative fast sweeping based eikonal solver for tilted orthorhombic media

    KAUST Repository

    Waheed, Umair bin

    2014-08-01

    Computing first-arrival traveltimes of quasi-P waves in the presence of anisotropy is important for high-end near-surface modeling, microseismic-source localization, and fractured-reservoir characterization, and requires solving an anisotropic eikonal equation. Anisotropy deviating from elliptical anisotropy introduces higher-order nonlinearity into the eikonal equation, which makes solving the eikonal equation a challenge. We address this challenge by iteratively solving a sequence of simpler tilted elliptically anisotropic eikonal equations. At each iteration, the source function is updated to capture the effects of the higher order nonlinear terms. We use Aitken extrapolation to speed up the convergence rate of the iterative algorithm. The result is an algorithm for first-arrival traveltime computations in tilted anisotropic media. We demonstrate our method on tilted transversely isotropic media and tilted orthorhombic media. Our numerical tests demonstrate that the proposed method can match the first arrivals obtained by wavefield extrapolation, even for strong anisotropy and complex structures. Therefore, for the cases where oneor two-point ray tracing fails, our method may be a potential substitute for computing traveltimes. Our approach can be extended to anisotropic media with lower symmetries, such as monoclinic or even triclinic media.

  10. An iterative fast sweeping based eikonal solver for tilted orthorhombic media

    KAUST Repository

    Waheed, Umair bin; Yarman, Can Evren; Flagg, Garret

    2014-01-01

    Computing first-arrival traveltimes of quasi-P waves in the presence of anisotropy is important for high-end near-surface modeling, microseismic-source localization, and fractured-reservoir characterization, and requires solving an anisotropic eikonal equation. Anisotropy deviating from elliptical anisotropy introduces higher-order nonlinearity into the eikonal equation, which makes solving the eikonal equation a challenge. We address this challenge by iteratively solving a sequence of simpler tilted elliptically anisotropic eikonal equations. At each iteration, the source function is updated to capture the effects of the higher order nonlinear terms. We use Aitken extrapolation to speed up the convergence rate of the iterative algorithm. The result is an algorithm for first-arrival traveltime computations in tilted anisotropic media. We demonstrate our method on tilted transversely isotropic media and tilted orthorhombic media. Our numerical tests demonstrate that the proposed method can match the first arrivals obtained by wavefield extrapolation, even for strong anisotropy and complex structures. Therefore, for the cases where oneor two-point ray tracing fails, our method may be a potential substitute for computing traveltimes. Our approach can be extended to anisotropic media with lower symmetries, such as monoclinic or even triclinic media.

  11. Iterated elliptic and hypergeometric integrals for Feynman diagrams

    Energy Technology Data Exchange (ETDEWEB)

    Ablinger, J.; Radu, C.S.; Schneider, C. [Johannes Kepler Univ., Linz (Austria). Research Inst. for Symbolic Computation (RISC); Bluemlein, J.; Freitas, A. de [Deutsches Elektronen-Synchrotron (DESY), Zeuthen (Germany); Van Hoeij, M.; Imamoglu, E. [Florida State Univ., Tallahassee, FL (United States). Dept. of Mathematics; Raab, C.G. [Linz Univ. (Austria). Inst. for Algebra

    2017-05-15

    We calculate 3-loop master integrals for heavy quark correlators and the 3-loop QCD corrections to the ρ-parameter. They obey non-factorizing differential equations of second order with more than three singularities, which cannot be factorized in Mellin-N space either. The solution of the homogeneous equations is possible in terms of convergent close integer power series as {sub 2}F{sub 1} Gauss hypergeometric functions at rational argument. In some cases, integrals of this type can be mapped to complete elliptic integrals at rational argument. This class of functions appears to be the next one arising in the calculation of more complicated Feynman integrals following the harmonic polylogarithms, generalized polylogarithms, cyclotomic harmonic polylogarithms, square-root valued iterated integrals, and combinations thereof, which appear in simpler cases. The inhomogeneous solution of the corresponding differential equations can be given in terms of iterative integrals, where the new innermost letter itself is not an iterative integral. A new class of iterative integrals is introduced containing letters in which (multiple) definite integrals appear as factors. For the elliptic case, we also derive the solution in terms of integrals over modular functions and also modular forms, using q-product and series representations implied by Jacobi's θ{sub i} functions and Dedekind's η-function. The corresponding representations can be traced back to polynomials out of Lambert-Eisenstein series, having representations also as elliptic polylogarithms, a q-factorial 1/η{sup κ}(τ), logarithms and polylogarithms of q and their q-integrals. Due to the specific form of the physical variable x(q) for different processes, different representations do usually appear. Numerical results are also presented.

  12. Iterated elliptic and hypergeometric integrals for Feynman diagrams

    International Nuclear Information System (INIS)

    Ablinger, J.; Radu, C.S.; Schneider, C.; Bluemlein, J.; Freitas, A. de; Van Hoeij, M.; Imamoglu, E.; Raab, C.G.

    2017-05-01

    We calculate 3-loop master integrals for heavy quark correlators and the 3-loop QCD corrections to the ρ-parameter. They obey non-factorizing differential equations of second order with more than three singularities, which cannot be factorized in Mellin-N space either. The solution of the homogeneous equations is possible in terms of convergent close integer power series as _2F_1 Gauss hypergeometric functions at rational argument. In some cases, integrals of this type can be mapped to complete elliptic integrals at rational argument. This class of functions appears to be the next one arising in the calculation of more complicated Feynman integrals following the harmonic polylogarithms, generalized polylogarithms, cyclotomic harmonic polylogarithms, square-root valued iterated integrals, and combinations thereof, which appear in simpler cases. The inhomogeneous solution of the corresponding differential equations can be given in terms of iterative integrals, where the new innermost letter itself is not an iterative integral. A new class of iterative integrals is introduced containing letters in which (multiple) definite integrals appear as factors. For the elliptic case, we also derive the solution in terms of integrals over modular functions and also modular forms, using q-product and series representations implied by Jacobi's θ_i functions and Dedekind's η-function. The corresponding representations can be traced back to polynomials out of Lambert-Eisenstein series, having representations also as elliptic polylogarithms, a q-factorial 1/η"κ(τ), logarithms and polylogarithms of q and their q-integrals. Due to the specific form of the physical variable x(q) for different processes, different representations do usually appear. Numerical results are also presented.

  13. Fermat’s ‘primitive solutions’ and some arithmetic of elliptic curves

    NARCIS (Netherlands)

    Top, Jaap

    1993-01-01

    In his work on Diophantine equations of the form y2=ax4+bx3+cx2+dx+e, Fermat introduced the notion of primitive solutions. In this expository note we intend to interpret this notion more geometrically, and explain what it means in terms of the arithmetic of elliptic curves. The specific equation

  14. Monge-Ampere equations and characteristic connection functors

    International Nuclear Information System (INIS)

    Tunitskii, D V

    2001-01-01

    We investigate contact equivalence of Monge-Ampere equations. We define a category of Monge-Ampere equations and introduce the notion of a characteristic connection functor. This functor maps the category of Monge-Ampere equations to the category of affine connections. We give a constructive description of the characteristic connection functors corresponding to three subcategories, which include a large class of Monge-Ampere equations of elliptic and hyperbolic type. This essentially reduces the contact equivalence problem for Monge-Ampere equations in the cases under study to the equivalence problem for affine connections. Using E. Cartan's familiar theory, we are thus able to state and prove several criteria of contact equivalence for a large class of elliptic and hyperbolic Monge-Ampere equations

  15. Performance of uncertainty quantification methodologies and linear solvers in cardiovascular simulations

    Science.gov (United States)

    Seo, Jongmin; Schiavazzi, Daniele; Marsden, Alison

    2017-11-01

    Cardiovascular simulations are increasingly used in clinical decision making, surgical planning, and disease diagnostics. Patient-specific modeling and simulation typically proceeds through a pipeline from anatomic model construction using medical image data to blood flow simulation and analysis. To provide confidence intervals on simulation predictions, we use an uncertainty quantification (UQ) framework to analyze the effects of numerous uncertainties that stem from clinical data acquisition, modeling, material properties, and boundary condition selection. However, UQ poses a computational challenge requiring multiple evaluations of the Navier-Stokes equations in complex 3-D models. To achieve efficiency in UQ problems with many function evaluations, we implement and compare a range of iterative linear solver and preconditioning techniques in our flow solver. We then discuss applications to patient-specific cardiovascular simulation and how the problem/boundary condition formulation in the solver affects the selection of the most efficient linear solver. Finally, we discuss performance improvements in the context of uncertainty propagation. Support from National Institute of Health (R01 EB018302) is greatly appreciated.

  16. Nuclear limits on gravitational waves from elliptically deformed pulsars

    International Nuclear Information System (INIS)

    Krastev, Plamen G.; Li Baoan; Worley, Aaron

    2008-01-01

    Gravitational radiation is a fundamental prediction of General Relativity. Elliptically deformed pulsars are among the possible sources emitting gravitational waves (GWs) with a strain-amplitude dependent upon the star's quadrupole moment, rotational frequency, and distance from the detector. We show that the gravitational wave strain amplitude h 0 depends strongly on the equation of state of neutron-rich stellar matter. Applying an equation of state with symmetry energy constrained by recent nuclear laboratory data, we set an upper limit on the strain-amplitude of GWs produced by elliptically deformed pulsars. Depending on details of the EOS, for several millisecond pulsars at distances 0.18 kpc to 0.35 kpc from Earth, the maximalh 0 is found to be in the range of ∼[0.4-1.5]x10 -24 . This prediction serves as the first direct nuclear constraint on the gravitational radiation. Its implications are discussed

  17. Elliptic Genera of Symmetric Products and Second Quantized Strings

    CERN Document Server

    Dijkgraaf, R; Verlinde, Erik; Verlinde, Herman L

    1997-01-01

    In this note we prove an identity that equates the elliptic genus partition function of a supersymmetric sigma model on the $N$-fold symmetric product $M^N/S_N$ of a manifold $M$ to the partition function of a second quantized string theory on the space $M \\times S^1$. The generating function of these elliptic genera is shown to be (almost) an automorphic form for $O(3,2,\\Z)$. In the context of D-brane dynamics, this result gives a precise computation of the free energy of a gas of D-strings inside a higher-dimensional brane.

  18. A second order discontinuous Galerkin fast sweeping method for Eikonal equations

    Science.gov (United States)

    Li, Fengyan; Shu, Chi-Wang; Zhang, Yong-Tao; Zhao, Hongkai

    2008-09-01

    In this paper, we construct a second order fast sweeping method with a discontinuous Galerkin (DG) local solver for computing viscosity solutions of a class of static Hamilton-Jacobi equations, namely the Eikonal equations. Our piecewise linear DG local solver is built on a DG method developed recently [Y. Cheng, C.-W. Shu, A discontinuous Galerkin finite element method for directly solving the Hamilton-Jacobi equations, Journal of Computational Physics 223 (2007) 398-415] for the time-dependent Hamilton-Jacobi equations. The causality property of Eikonal equations is incorporated into the design of this solver. The resulting local nonlinear system in the Gauss-Seidel iterations is a simple quadratic system and can be solved explicitly. The compactness of the DG method and the fast sweeping strategy lead to fast convergence of the new scheme for Eikonal equations. Extensive numerical examples verify efficiency, convergence and second order accuracy of the proposed method.

  19. On some classes of breather lattice solutions to the sinh-Gordon equation

    International Nuclear Information System (INIS)

    Fu Zuntao; Liu Shikuo

    2007-01-01

    In this paper, dependent and independent variable transformations are introduced to solve the sinh-Gordon equation by using the knowledge of the elliptic equation and Jacobian elliptic functions. It is shown that different kinds of solutions can be obtained to the sinh-Gordon equation, including breather lattice solutions and periodic wave solutions. (orig.)

  20. A CFD Heterogeneous Parallel Solver Based on Collaborating CPU and GPU

    Science.gov (United States)

    Lai, Jianqi; Tian, Zhengyu; Li, Hua; Pan, Sha

    2018-03-01

    Since Graphic Processing Unit (GPU) has a strong ability of floating-point computation and memory bandwidth for data parallelism, it has been widely used in the areas of common computing such as molecular dynamics (MD), computational fluid dynamics (CFD) and so on. The emergence of compute unified device architecture (CUDA), which reduces the complexity of compiling program, brings the great opportunities to CFD. There are three different modes for parallel solution of NS equations: parallel solver based on CPU, parallel solver based on GPU and heterogeneous parallel solver based on collaborating CPU and GPU. As we can see, GPUs are relatively rich in compute capacity but poor in memory capacity and the CPUs do the opposite. We need to make full use of the GPUs and CPUs, so a CFD heterogeneous parallel solver based on collaborating CPU and GPU has been established. Three cases are presented to analyse the solver’s computational accuracy and heterogeneous parallel efficiency. The numerical results agree well with experiment results, which demonstrate that the heterogeneous parallel solver has high computational precision. The speedup on a single GPU is more than 40 for laminar flow, it decreases for turbulent flow, but it still can reach more than 20. What’s more, the speedup increases as the grid size becomes larger.

  1. New Boundary Constraints for Elliptic Systems used in Grid Generation Problems

    Science.gov (United States)

    Kaul, Upender K.; Clancy, Daniel (Technical Monitor)

    2002-01-01

    This paper discusses new boundary constraints for elliptic partial differential equations as used in grid generation problems in generalized curvilinear coordinate systems. These constraints, based on the principle of local conservation of thermal energy in the vicinity of the boundaries, are derived using the Green's Theorem. They uniquely determine the so called decay parameters in the source terms of these elliptic systems. These constraints' are designed for boundary clustered grids where large gradients in physical quantities need to be resolved adequately. It is observed that the present formulation also works satisfactorily for mild clustering. Therefore, a closure for the decay parameter specification for elliptic grid generation problems has been provided resulting in a fully automated elliptic grid generation technique. Thus, there is no need for a parametric study of these decay parameters since the new constraints fix them uniquely. It is also shown that for Neumann type boundary conditions, these boundary constraints uniquely determine the solution to the internal elliptic problem thus eliminating the non-uniqueness of the solution of an internal Neumann boundary value grid generation problem.

  2. Hierarchical matrix techniques for the solution of elliptic equations

    KAUST Repository

    Chávez, Gustavo

    2014-05-04

    Hierarchical matrix approximations are a promising tool for approximating low-rank matrices given the compactness of their representation and the economy of the operations between them. Integral and differential operators have been the major applications of this technology, but they can be applied into other areas where low-rank properties exist. Such is the case of the Block Cyclic Reduction algorithm, which is used as a direct solver for the constant-coefficient Poisson quation. We explore the variable-coefficient case, also using Block Cyclic reduction, with the addition of Hierarchical Matrices to represent matrix blocks, hence improving the otherwise O(N2) algorithm, into an efficient O(N) algorithm.

  3. Chemical Mechanism Solvers in Air Quality Models

    Directory of Open Access Journals (Sweden)

    John C. Linford

    2011-09-01

    Full Text Available The solution of chemical kinetics is one of the most computationally intensivetasks in atmospheric chemical transport simulations. Due to the stiff nature of the system,implicit time stepping algorithms which repeatedly solve linear systems of equations arenecessary. This paper reviews the issues and challenges associated with the construction ofefficient chemical solvers, discusses several families of algorithms, presents strategies forincreasing computational efficiency, and gives insight into implementing chemical solverson accelerated computer architectures.

  4. Code Samples Used for Complexity and Control

    Science.gov (United States)

    Ivancevic, Vladimir G.; Reid, Darryn J.

    2015-11-01

    The following sections are included: * MathematicaⓇ Code * Generic Chaotic Simulator * Vector Differential Operators * NLS Explorer * 2C++ Code * C++ Lambda Functions for Real Calculus * Accelerometer Data Processor * Simple Predictor-Corrector Integrator * Solving the BVP with the Shooting Method * Linear Hyperbolic PDE Solver * Linear Elliptic PDE Solver * Method of Lines for a Set of the NLS Equations * C# Code * Iterative Equation Solver * Simulated Annealing: A Function Minimum * Simple Nonlinear Dynamics * Nonlinear Pendulum Simulator * Lagrangian Dynamics Simulator * Complex-Valued Crowd Attractor Dynamics * Freeform Fortran Code * Lorenz Attractor Simulator * Complex Lorenz Attractor * Simple SGE Soliton * Complex Signal Presentation * Gaussian Wave Packet * Hermitian Matrices * Euclidean L2-Norm * Vector/Matrix Operations * Plain C-Code: Levenberg-Marquardt Optimizer * Free Basic Code: 2D Crowd Dynamics with 3000 Agents

  5. An AMR capable finite element diffusion solver for ALE hydrocodes [An AMR capable diffusion solver for ALE-AMR

    Energy Technology Data Exchange (ETDEWEB)

    Fisher, A. C. [Lawrence Livermore National Lab. (LLNL), Livermore, CA (United States); Bailey, D. S. [Lawrence Livermore National Lab. (LLNL), Livermore, CA (United States); Kaiser, T. B. [Lawrence Livermore National Lab. (LLNL), Livermore, CA (United States); Eder, D. C. [Lawrence Livermore National Lab. (LLNL), Livermore, CA (United States); Gunney, B. T. N. [Lawrence Livermore National Lab. (LLNL), Livermore, CA (United States); Masters, N. D. [Lawrence Livermore National Lab. (LLNL), Livermore, CA (United States); Koniges, A. E. [Lawrence Berkeley National Lab. (LBNL), Berkeley, CA (United States); Anderson, R. W. [Lawrence Livermore National Lab. (LLNL), Livermore, CA (United States)

    2015-02-01

    Here, we present a novel method for the solution of the diffusion equation on a composite AMR mesh. This approach is suitable for including diffusion based physics modules to hydrocodes that support ALE and AMR capabilities. To illustrate, we proffer our implementations of diffusion based radiation transport and heat conduction in a hydrocode called ALE-AMR. Numerical experiments conducted with the diffusion solver and associated physics packages yield 2nd order convergence in the L2 norm.

  6. An immersed interface vortex particle-mesh solver

    Science.gov (United States)

    Marichal, Yves; Chatelain, Philippe; Winckelmans, Gregoire

    2014-11-01

    An immersed interface-enabled vortex particle-mesh (VPM) solver is presented for the simulation of 2-D incompressible viscous flows, in the framework of external aerodynamics. Considering the simulation of free vortical flows, such as wakes and jets, vortex particle-mesh methods already provide a valuable alternative to standard CFD methods, thanks to the interesting numerical properties arising from its Lagrangian nature. Yet, accounting for solid bodies remains challenging, despite the extensive research efforts that have been made for several decades. The present immersed interface approach aims at improving the consistency and the accuracy of one very common technique (based on Lighthill's model) for the enforcement of the no-slip condition at the wall in vortex methods. Targeting a sharp treatment of the wall calls for substantial modifications at all computational levels of the VPM solver. More specifically, the solution of the underlying Poisson equation, the computation of the diffusion term and the particle-mesh interpolation are adapted accordingly and the spatial accuracy is assessed. The immersed interface VPM solver is subsequently validated on the simulation of some challenging impulsively started flows, such as the flow past a cylinder and that past an airfoil. Research Fellow (PhD student) of the F.R.S.-FNRS of Belgium.

  7. Direct solvers performance on h-adapted grids

    KAUST Repository

    Paszynski, Maciej; Pardo, David; Calo, Victor M.

    2015-01-01

    We analyse the performance of direct solvers when applied to a system of linear equations arising from an hh-adapted, C0C0 finite element space. Theoretical estimates are derived for typical hh-refinement patterns arising as a result of a point, edge, or face singularity as well as boundary layers. They are based on the elimination trees constructed specifically for the considered grids. Theoretical estimates are compared with experiments performed with MUMPS using the nested-dissection algorithm for construction of the elimination tree from METIS library. The numerical experiments provide the same performance for the cases where our trees are identical with those constructed by the nested-dissection algorithm, and worse performance for some cases where our trees are different. We also present numerical experiments for the cases with mixed singularities, where how to construct optimal elimination trees is unknown. In all analysed cases, the use of hh-adaptive grids significantly reduces the cost of the direct solver algorithm per unknown as compared to uniform grids. The theoretical estimates predict and the experimental data confirm that the computational complexity is linear for various refinement patterns. In most cases, the cost of the direct solver per unknown is lower when employing anisotropic refinements as opposed to isotropic ones.

  8. Direct solvers performance on h-adapted grids

    KAUST Repository

    Paszynski, Maciej

    2015-05-27

    We analyse the performance of direct solvers when applied to a system of linear equations arising from an hh-adapted, C0C0 finite element space. Theoretical estimates are derived for typical hh-refinement patterns arising as a result of a point, edge, or face singularity as well as boundary layers. They are based on the elimination trees constructed specifically for the considered grids. Theoretical estimates are compared with experiments performed with MUMPS using the nested-dissection algorithm for construction of the elimination tree from METIS library. The numerical experiments provide the same performance for the cases where our trees are identical with those constructed by the nested-dissection algorithm, and worse performance for some cases where our trees are different. We also present numerical experiments for the cases with mixed singularities, where how to construct optimal elimination trees is unknown. In all analysed cases, the use of hh-adaptive grids significantly reduces the cost of the direct solver algorithm per unknown as compared to uniform grids. The theoretical estimates predict and the experimental data confirm that the computational complexity is linear for various refinement patterns. In most cases, the cost of the direct solver per unknown is lower when employing anisotropic refinements as opposed to isotropic ones.

  9. Numerical Platon: A unified linear equation solver interface by CEA for solving open foe scientific applications

    International Nuclear Information System (INIS)

    Secher, Bernard; Belliard, Michel; Calvin, Christophe

    2009-01-01

    This paper describes a tool called 'Numerical Platon' developed by the French Atomic Energy Commission (CEA). It provides a freely available (GNU LGPL license) interface for coupling scientific computing applications to various freeware linear solver libraries (essentially PETSc, SuperLU and HyPre), together with some proprietary CEA solvers, for high-performance computers that may be used in industrial software written in various programming languages. This tool was developed as part of considerable efforts by the CEA Nuclear Energy Division in the past years to promote massively parallel software and on-shelf parallel tools to help develop new generation simulation codes. After the presentation of the package architecture and the available algorithms, we show examples of how Numerical Platon is used in sequential and parallel CEA codes. Comparing with in-house solvers, the gain in terms of increases in computation capacities or in terms of parallel performances is notable, without considerable extra development cost

  10. Numerical Platon: A unified linear equation solver interface by CEA for solving open foe scientific applications

    Energy Technology Data Exchange (ETDEWEB)

    Secher, Bernard [French Atomic Energy Commission (CEA), Nuclear Energy Division (DEN) (France); CEA Saclay DM2S/SFME/LGLS, Bat. 454, F-91191 Gif-sur-Yvette Cedex (France)], E-mail: bsecher@cea.fr; Belliard, Michel [French Atomic Energy Commission (CEA), Nuclear Energy Division (DEN) (France); CEA Cadarache DER/SSTH/LMDL, Bat. 238, F-13108 Saint-Paul-lez-Durance Cedex (France); Calvin, Christophe [French Atomic Energy Commission (CEA), Nuclear Energy Division (DEN) (France); CEA Saclay DM2S/SERMA/LLPR, Bat. 470, F-91191 Gif-sur-Yvette Cedex (France)

    2009-01-15

    This paper describes a tool called 'Numerical Platon' developed by the French Atomic Energy Commission (CEA). It provides a freely available (GNU LGPL license) interface for coupling scientific computing applications to various freeware linear solver libraries (essentially PETSc, SuperLU and HyPre), together with some proprietary CEA solvers, for high-performance computers that may be used in industrial software written in various programming languages. This tool was developed as part of considerable efforts by the CEA Nuclear Energy Division in the past years to promote massively parallel software and on-shelf parallel tools to help develop new generation simulation codes. After the presentation of the package architecture and the available algorithms, we show examples of how Numerical Platon is used in sequential and parallel CEA codes. Comparing with in-house solvers, the gain in terms of increases in computation capacities or in terms of parallel performances is notable, without considerable extra development cost.

  11. Nehari manifold for non-local elliptic operator with concave–convex ...

    Indian Academy of Sciences (India)

    Introduction. We consider the following p-fractional Laplace equation ... ators of elliptic type due to concrete real world applications in finance, thin obstacle .... Due to the non-localness of the operator LK, we define the linear space as follows:.

  12. An Investigation of the Performance of the Colored Gauss-Seidel Solver on CPU and GPU

    International Nuclear Information System (INIS)

    Yoon, Jong Seon; Choi, Hyoung Gwon; Jeon, Byoung Jin

    2017-01-01

    The performance of the colored Gauss–Seidel solver on CPU and GPU was investigated for the two- and three-dimensional heat conduction problems by using different mesh sizes. The heat conduction equation was discretized by the finite difference method and finite element method. The CPU yielded good performance for small problems but deteriorated when the total memory required for computing was larger than the cache memory for large problems. In contrast, the GPU performed better as the mesh size increased because of the latency hiding technique. Further, GPU computation by the colored Gauss–Siedel solver was approximately 7 times that by the single CPU. Furthermore, the colored Gauss–Seidel solver was found to be approximately twice that of the Jacobi solver when parallel computing was conducted on the GPU.

  13. An Investigation of the Performance of the Colored Gauss-Seidel Solver on CPU and GPU

    Energy Technology Data Exchange (ETDEWEB)

    Yoon, Jong Seon; Choi, Hyoung Gwon [Seoul Nat’l Univ. of Science and Technology, Seoul (Korea, Republic of); Jeon, Byoung Jin [Yonsei Univ., Seoul (Korea, Republic of)

    2017-02-15

    The performance of the colored Gauss–Seidel solver on CPU and GPU was investigated for the two- and three-dimensional heat conduction problems by using different mesh sizes. The heat conduction equation was discretized by the finite difference method and finite element method. The CPU yielded good performance for small problems but deteriorated when the total memory required for computing was larger than the cache memory for large problems. In contrast, the GPU performed better as the mesh size increased because of the latency hiding technique. Further, GPU computation by the colored Gauss–Siedel solver was approximately 7 times that by the single CPU. Furthermore, the colored Gauss–Seidel solver was found to be approximately twice that of the Jacobi solver when parallel computing was conducted on the GPU.

  14. Tests of a 3D Self Magnetic Field Solver in the Finite Element Gun Code MICHELLE

    CERN Document Server

    Nelson, Eric M

    2005-01-01

    We have recently implemented a prototype 3d self magnetic field solver in the finite-element gun code MICHELLE. The new solver computes the magnetic vector potential on unstructured grids. The solver employs edge basis functions in the curl-curl formulation of the finite-element method. A novel current accumulation algorithm takes advantage of the unstructured grid particle tracker to produce a compatible source vector, for which the singular matrix equation is easily solved by the conjugate gradient method. We will present some test cases demonstrating the capabilities of the prototype 3d self magnetic field solver. One test case is self magnetic field in a square drift tube. Another is a relativistic axisymmetric beam freely expanding in a round pipe.

  15. DKE: a fast numerical solver for the 3-D relativistic bounce-averaged electron drift kinetic equation

    Energy Technology Data Exchange (ETDEWEB)

    Decker, J.; Peysson, Y

    2004-12-01

    A new original code for solving the 3-D relativistic and bounce-averaged electron drift kinetic equation is presented. It designed for the current drive problem in tokamak with an arbitrary magnetic equilibrium. This tool allows self-consistent calculations of the bootstrap current in presence of other external current sources. RF current drive for arbitrary type of waves may be used. Several moments of the electron distribution function are determined, like the exact and effective fractions of trapped electrons, the plasma current, absorbed RF power, runaway and magnetic ripple loss rates and non-thermal Bremsstrahlung. Advanced numerical techniques have been used to make it the first fully implicit (reverse time) 3-D solver, particularly well designed for implementation in a chain of code for realistic current drive calculations in high {beta}{sub p} plasmas. All the details of the physics background and the numerical scheme are presented, as well a some examples to illustrate main code capabilities. Several important numerical points are addressed concerning code stability and potential numerical and physical limitations. (authors)

  16. DKE: a fast numerical solver for the 3-D relativistic bounce-averaged electron drift kinetic equation

    International Nuclear Information System (INIS)

    Decker, J.; Peysson, Y.

    2004-12-01

    A new original code for solving the 3-D relativistic and bounce-averaged electron drift kinetic equation is presented. It designed for the current drive problem in tokamak with an arbitrary magnetic equilibrium. This tool allows self-consistent calculations of the bootstrap current in presence of other external current sources. RF current drive for arbitrary type of waves may be used. Several moments of the electron distribution function are determined, like the exact and effective fractions of trapped electrons, the plasma current, absorbed RF power, runaway and magnetic ripple loss rates and non-thermal Bremsstrahlung. Advanced numerical techniques have been used to make it the first fully implicit (reverse time) 3-D solver, particularly well designed for implementation in a chain of code for realistic current drive calculations in high β p plasmas. All the details of the physics background and the numerical scheme are presented, as well a some examples to illustrate main code capabilities. Several important numerical points are addressed concerning code stability and potential numerical and physical limitations. (authors)

  17. High order Poisson Solver for unbounded flows

    DEFF Research Database (Denmark)

    Hejlesen, Mads Mølholm; Rasmussen, Johannes Tophøj; Chatelain, Philippe

    2015-01-01

    This paper presents a high order method for solving the unbounded Poisson equation on a regular mesh using a Green’s function solution. The high order convergence was achieved by formulating mollified integration kernels, that were derived from a filter regularisation of the solution field....... The method was implemented on a rectangular domain using fast Fourier transforms (FFT) to increase computational efficiency. The Poisson solver was extended to directly solve the derivatives of the solution. This is achieved either by including the differential operator in the integration kernel...... the equations of fluid mechanics as an example, but can be used in many physical problems to solve the Poisson equation on a rectangular unbounded domain. For the two-dimensional case we propose an infinitely smooth test function which allows for arbitrary high order convergence. Using Gaussian smoothing...

  18. Refined functional relations for the elliptic SOS model

    Energy Technology Data Exchange (ETDEWEB)

    Galleas, W., E-mail: w.galleas@uu.nl [ARC Centre of Excellence for the Mathematics and Statistics of Complex Systems, University of Melbourne, VIC 3010 (Australia)

    2013-02-21

    In this work we refine the method presented in Galleas (2012) [1] and obtain a novel kind of functional equation determining the partition function of the elliptic SOS model with domain wall boundaries. This functional relation arises from the dynamical Yang-Baxter relation and its solution is given in terms of multiple contour integrals.

  19. Refined functional relations for the elliptic SOS model

    International Nuclear Information System (INIS)

    Galleas, W.

    2013-01-01

    In this work we refine the method presented in Galleas (2012) [1] and obtain a novel kind of functional equation determining the partition function of the elliptic SOS model with domain wall boundaries. This functional relation arises from the dynamical Yang–Baxter relation and its solution is given in terms of multiple contour integrals.

  20. The multi-order envelope periodic solutions to the nonlinear Schrodinger equation and cubic nonlinear Schrodinger equation

    International Nuclear Information System (INIS)

    Xiao Yafeng; Xue Haili; Zhang Hongqing

    2011-01-01

    Based on Jacobi elliptic function and the Lame equation, the perturbation method is applied to get the multi-order envelope periodic solutions of the nonlinear Schrodinger equation and cubic nonlinear Schrodinger equation. These multi-order envelope periodic solutions can degenerate into the different envelope solitary solutions. (authors)

  1. On multigrid solution of the implicit equations of hydrodynamics. Experiments for the compressible Euler equations in general coordinates

    Science.gov (United States)

    Kifonidis, K.; Müller, E.

    2012-08-01

    Aims: We describe and study a family of new multigrid iterative solvers for the multidimensional, implicitly discretized equations of hydrodynamics. Schemes of this class are free of the Courant-Friedrichs-Lewy condition. They are intended for simulations in which widely differing wave propagation timescales are present. A preferred solver in this class is identified. Applications to some simple stiff test problems that are governed by the compressible Euler equations, are presented to evaluate the convergence behavior, and the stability properties of this solver. Algorithmic areas are determined where further work is required to make the method sufficiently efficient and robust for future application to difficult astrophysical flow problems. Methods: The basic equations are formulated and discretized on non-orthogonal, structured curvilinear meshes. Roe's approximate Riemann solver and a second-order accurate reconstruction scheme are used for spatial discretization. Implicit Runge-Kutta (ESDIRK) schemes are employed for temporal discretization. The resulting discrete equations are solved with a full-coarsening, non-linear multigrid method. Smoothing is performed with multistage-implicit smoothers. These are applied here to the time-dependent equations by means of dual time stepping. Results: For steady-state problems, our results show that the efficiency of the present approach is comparable to the best implicit solvers for conservative discretizations of the compressible Euler equations that can be found in the literature. The use of red-black as opposed to symmetric Gauss-Seidel iteration in the multistage-smoother is found to have only a minor impact on multigrid convergence. This should enable scalable parallelization without having to seriously compromise the method's algorithmic efficiency. For time-dependent test problems, our results reveal that the multigrid convergence rate degrades with increasing Courant numbers (i.e. time step sizes). Beyond a

  2. Extreme Scale FMM-Accelerated Boundary Integral Equation Solver for Wave Scattering

    KAUST Repository

    AbdulJabbar, Mustafa Abdulmajeed

    2018-03-27

    Algorithmic and architecture-oriented optimizations are essential for achieving performance worthy of anticipated energy-austere exascale systems. In this paper, we present an extreme scale FMM-accelerated boundary integral equation solver for wave scattering, which uses FMM as a matrix-vector multiplication inside the GMRES iterative method. Our FMM Helmholtz kernels treat nontrivial singular and near-field integration points. We implement highly optimized kernels for both shared and distributed memory, targeting emerging Intel extreme performance HPC architectures. We extract the potential thread- and data-level parallelism of the key Helmholtz kernels of FMM. Our application code is well optimized to exploit the AVX-512 SIMD units of Intel Skylake and Knights Landing architectures. We provide different performance models for tuning the task-based tree traversal implementation of FMM, and develop optimal architecture-specific and algorithm aware partitioning, load balancing, and communication reducing mechanisms to scale up to 6,144 compute nodes of a Cray XC40 with 196,608 hardware cores. With shared memory optimizations, we achieve roughly 77% of peak single precision floating point performance of a 56-core Skylake processor, and on average 60% of peak single precision floating point performance of a 72-core KNL. These numbers represent nearly 5.4x and 10x speedup on Skylake and KNL, respectively, compared to the baseline scalar code. With distributed memory optimizations, on the other hand, we report near-optimal efficiency in the weak scalability study with respect to both the logarithmic communication complexity as well as the theoretical scaling complexity of FMM. In addition, we exhibit up to 85% efficiency in strong scaling. We compute in excess of 2 billion DoF on the full-scale of the Cray XC40 supercomputer.

  3. 3D casing-distributor analysis with a novel block coupled OpenFOAM solver for hydraulic design application

    International Nuclear Information System (INIS)

    Devals, C; Zhang, Y; Dompierre, J; Guibault, F; Vu, T C; Mangani, L

    2014-01-01

    Nowadays, computational fluid dynamics is commonly used by design engineers to evaluate and compare losses in hydraulic components as it is less expensive and less time consuming than model tests. For that purpose, an automatic tool for casing and distributor analysis will be presented in this paper. An in-house mesh generator and a Reynolds Averaged Navier-Stokes equation solver using the standard k-ω SST turbulence model will be used to perform all computations. Two solvers based on the C++ OpenFOAM library will be used and compared to a commercial solver. The performance of the new fully coupled block solver developed by the University of Lucerne and Andritz will be compared to the standard 1.6ext segregated simpleFoam solver and to a commercial solver. In this study, relative comparisons of different geometries of casing and distributor will be performed. The present study is thus aimed at validating the block solver and the tool chain and providing design engineers with a faster and more reliable analysis tool that can be integrated into their design process

  4. Utilization of integrated Michaelis-Menten equations for enzyme inhibition diagnosis and determination of kinetic constants using Solver supplement of Microsoft Office Excel.

    Science.gov (United States)

    Bezerra, Rui M F; Fraga, Irene; Dias, Albino A

    2013-01-01

    Enzyme kinetic parameters are usually determined from initial rates nevertheless, laboratory instruments only measure substrate or product concentration versus reaction time (progress curves). To overcome this problem we present a methodology which uses integrated models based on Michaelis-Menten equation. The most severe practical limitation of progress curve analysis occurs when the enzyme shows a loss of activity under the chosen assay conditions. To avoid this problem it is possible to work with the same experimental points utilized for initial rates determination. This methodology is illustrated by the use of integrated kinetic equations with the well-known reaction catalyzed by alkaline phosphatase enzyme. In this work nonlinear regression was performed with the Solver supplement (Microsoft Office Excel). It is easy to work with and track graphically the convergence of SSE (sum of square errors). The diagnosis of enzyme inhibition was performed according to Akaike information criterion. Copyright © 2012 Elsevier Ireland Ltd. All rights reserved.

  5. Scalable domain decomposition solvers for stochastic PDEs in high performance computing

    International Nuclear Information System (INIS)

    Desai, Ajit; Pettit, Chris; Poirel, Dominique; Sarkar, Abhijit

    2017-01-01

    Stochastic spectral finite element models of practical engineering systems may involve solutions of linear systems or linearized systems for non-linear problems with billions of unknowns. For stochastic modeling, it is therefore essential to design robust, parallel and scalable algorithms that can efficiently utilize high-performance computing to tackle such large-scale systems. Domain decomposition based iterative solvers can handle such systems. And though these algorithms exhibit excellent scalabilities, significant algorithmic and implementational challenges exist to extend them to solve extreme-scale stochastic systems using emerging computing platforms. Intrusive polynomial chaos expansion based domain decomposition algorithms are extended here to concurrently handle high resolution in both spatial and stochastic domains using an in-house implementation. Sparse iterative solvers with efficient preconditioners are employed to solve the resulting global and subdomain level local systems through multi-level iterative solvers. We also use parallel sparse matrix–vector operations to reduce the floating-point operations and memory requirements. Numerical and parallel scalabilities of these algorithms are presented for the diffusion equation having spatially varying diffusion coefficient modeled by a non-Gaussian stochastic process. Scalability of the solvers with respect to the number of random variables is also investigated.

  6. Weak solutions of magma equations

    International Nuclear Information System (INIS)

    Krishnan, E.V.

    1999-01-01

    Periodic solutions in terms of Jacobian cosine elliptic functions have been obtained for a set of values of two physical parameters for the magma equation which do not reduce to solitary-wave solutions. It was also obtained solitary-wave solutions for another set of these parameters as an infinite period limit of periodic solutions in terms of Weierstrass and Jacobian elliptic functions

  7. Robust Multiscale Iterative Solvers for Nonlinear Flows in Highly Heterogeneous Media

    KAUST Repository

    Efendiev, Y.

    2012-08-01

    In this paper, we study robust iterative solvers for finite element systems resulting in approximation of steady-state Richards\\' equation in porous media with highly heterogeneous conductivity fields. It is known that in such cases the contrast, ratio between the highest and lowest values of the conductivity, can adversely affect the performance of the preconditioners and, consequently, a design of robust preconditioners is important for many practical applications. The proposed iterative solvers consist of two kinds of iterations, outer and inner iterations. Outer iterations are designed to handle nonlinearities by linearizing the equation around the previous solution state. As a result of the linearization, a large-scale linear system needs to be solved. This linear system is solved iteratively (called inner iterations), and since it can have large variations in the coefficients, a robust preconditioner is needed. First, we show that under some assumptions the number of outer iterations is independent of the contrast. Second, based on the recently developed iterative methods, we construct a class of preconditioners that yields convergence rate that is independent of the contrast. Thus, the proposed iterative solvers are optimal with respect to the large variation in the physical parameters. Since the same preconditioner can be reused in every outer iteration, this provides an additional computational savings in the overall solution process. Numerical tests are presented to confirm the theoretical results. © 2012 Global-Science Press.

  8. Fast computation of complete elliptic integrals and Jacobian elliptic functions

    Science.gov (United States)

    Fukushima, Toshio

    2009-12-01

    As a preparation step to compute Jacobian elliptic functions efficiently, we created a fast method to calculate the complete elliptic integral of the first and second kinds, K( m) and E( m), for the standard domain of the elliptic parameter, 0 procedure to compute simultaneously three Jacobian elliptic functions, sn( u| m), cn( u| m), and dn( u| m), by repeated usage of the double argument formulae starting from the Maclaurin series expansions with respect to the elliptic argument, u, after its domain is reduced to the standard range, 0 ≤ u procedure is 25-70% faster than the methods based on the Gauss transformation such as Bulirsch’s algorithm, sncndn, quoted in the Numerical Recipes even if the acceleration of computation of K( m) is not taken into account.

  9. Integral propagator solvers for Vlasov-Fokker-Planck equations

    International Nuclear Information System (INIS)

    Donoso, J M; Rio, E del

    2007-01-01

    We briefly discuss the use of short-time integral propagators on solving the so-called Vlasov-Fokker-Planck equation for the dynamics of a distribution function. For this equation, the diffusion tensor is singular and the usual Gaussian representation of the short-time propagator is no longer valid. However, we prove that the path-integral approach on solving the equation is, in fact, reliable by means of our generalized propagator, which is obtained through the construction of an auxiliary solvable Fokker-Planck equation. The new representation of the grid-free advancing scheme describes the inherent cross- and self-diffusion processes, in both velocity and configuration spaces, in a natural manner, although these processes are not explicitly depicted in the differential equation. We also show that some splitting methods, as well as some finite-difference schemes, could fail in describing the aforementioned diffusion processes, governed in the whole phase space only by the velocity diffusion tensor. The short-time transition probability offers a stable and robust numerical algorithm that preserves the distribution positiveness and its norm, ensuring the smoothness of the evolving solution at any time step. (fast track communication)

  10. Nearly Interactive Parabolized Navier-Stokes Solver for High Speed Forebody and Inlet Flows

    Science.gov (United States)

    Benson, Thomas J.; Liou, May-Fun; Jones, William H.; Trefny, Charles J.

    2009-01-01

    A system of computer programs is being developed for the preliminary design of high speed inlets and forebodies. The system comprises four functions: geometry definition, flow grid generation, flow solver, and graphics post-processor. The system runs on a dedicated personal computer using the Windows operating system and is controlled by graphical user interfaces written in MATLAB (The Mathworks, Inc.). The flow solver uses the Parabolized Navier-Stokes equations to compute millions of mesh points in several minutes. Sample two-dimensional and three-dimensional calculations are demonstrated in the paper.

  11. Growth of meromorphic solutions of delay differential equations

    OpenAIRE

    Halburd, Rod; Korhonen, Risto

    2016-01-01

    Necessary conditions are obtained for certain types of rational delay differential equations to admit a non-rational meromorphic solution of hyper-order less than one. The equations obtained include delay Painlev\\'e equations and equations solved by elliptic functions.

  12. Solving very large scattering problems using a parallel PWTD-enhanced surface integral equation solver

    KAUST Repository

    Liu, Yang; Bagci, Hakan; Michielssen, Eric

    2013-01-01

    numbers of temporal and spatial basis functions discretizing the current [Shanker et al., IEEE Trans. Antennas Propag., 51, 628-641, 2003]. In the past, serial versions of these solvers have been successfully applied to the analysis of scattering from

  13. An efficient eikonal solver for tilted transversely isotropic and tilted orthorhombic media

    KAUST Repository

    Waheed, Umair bin

    2014-01-01

    Computing first-arrival traveltimes in the presence of anisotropy is important for high-end near surface modeling, microseismic source localization, and fractured reservoir characterization. Anisotropy deviating from elliptical anisotropy introduces higher-order nonlinearity into the eikonal equation, which makes solving the equation a challenging task. We address this challenge by iteratively solving a sequence of simpler tilted elliptically anisotropic eikonal equations. At each iteration, the source function is updated to capture the effects due to the higher order nonlinear terms in the anisotropy. We use Aitken extrapolation to speed up the convergence rate of the iterative algorithm. The result is an efficient algorithm for firstarrival traveltime computations in tilted anisotropic media. We demonstrate the proposed method for the tilted transversely isotropic media and the tilted orthorhombic media. Numerical tests show that the proposed method is feasible and produces results that are comparable to wavefield extrapolation, even for strongly anisotropic and complex structures. Therefore, for the cases where one or two-point ray tracing fails, our method may be a potential substitute for computing traveltimes.

  14. Approximate Riemann solver for the two-fluid plasma model

    International Nuclear Information System (INIS)

    Shumlak, U.; Loverich, J.

    2003-01-01

    An algorithm is presented for the simulation of plasma dynamics using the two-fluid plasma model. The two-fluid plasma model is more general than the magnetohydrodynamic (MHD) model often used for plasma dynamic simulations. The two-fluid equations are derived in divergence form and an approximate Riemann solver is developed to compute the fluxes of the electron and ion fluids at the computational cell interfaces and an upwind characteristic-based solver to compute the electromagnetic fields. The source terms that couple the fluids and fields are treated implicitly to relax the stiffness. The algorithm is validated with the coplanar Riemann problem, Langmuir plasma oscillations, and the electromagnetic shock problem that has been simulated with the MHD plasma model. A numerical dispersion relation is also presented that demonstrates agreement with analytical plasma waves

  15. Monotone difference schemes for weakly coupled elliptic and parabolic systems

    NARCIS (Netherlands)

    P. Matus (Piotr); F.J. Gaspar Lorenz (Franscisco); L. M. Hieu (Le Minh); V.T.K. Tuyen (Vo Thi Kim)

    2017-01-01

    textabstractThe present paper is devoted to the development of the theory of monotone difference schemes, approximating the so-called weakly coupled system of linear elliptic and quasilinear parabolic equations. Similarly to the scalar case, the canonical form of the vector-difference schemes is

  16. On nonlocal semi linear elliptic problem with an indefinite term

    International Nuclear Information System (INIS)

    Yechoui, Akila

    2007-08-01

    The aim of this paper is to investigate the existence of solutions of a nonlocal semi linear elliptic equation with an indefinite term. The monotone method, the method of upper and lower solutions and the classical maximum principle are used to obtain our results. (author)

  17. EXACT TRAVELLING WAVE SOLUTIONS TO BBM EQUATION

    Institute of Scientific and Technical Information of China (English)

    2009-01-01

    Abundant new travelling wave solutions to the BBM (Benjamin-Bona-Mahoni) equation are obtained by the generalized Jacobian elliptic function method. This method can be applied to other nonlinear evolution equations.

  18. Newton-Krylov-BDDC solvers for nonlinear cardiac mechanics

    KAUST Repository

    Pavarino, L.F.; Scacchi, S.; Zampini, Stefano

    2015-01-01

    The aim of this work is to design and study a Balancing Domain Decomposition by Constraints (BDDC) solver for the nonlinear elasticity system modeling the mechanical deformation of cardiac tissue. The contraction–relaxation process in the myocardium is induced by the generation and spread of the bioelectrical excitation throughout the tissue and it is mathematically described by the coupling of cardiac electro-mechanical models consisting of systems of partial and ordinary differential equations. In this study, the discretization of the electro-mechanical models is performed by Q1 finite elements in space and semi-implicit finite difference schemes in time, leading to the solution of a large-scale linear system for the bioelectrical potentials and a nonlinear system for the mechanical deformation at each time step of the simulation. The parallel mechanical solver proposed in this paper consists in solving the nonlinear system with a Newton-Krylov-BDDC method, based on the parallel solution of local mechanical problems and a coarse problem for the so-called primal unknowns. Three-dimensional parallel numerical tests on different machines show that the proposed parallel solver is scalable in the number of subdomains, quasi-optimal in the ratio of subdomain to mesh sizes, and robust with respect to tissue anisotropy.

  19. Newton-Krylov-BDDC solvers for nonlinear cardiac mechanics

    KAUST Repository

    Pavarino, L.F.

    2015-07-18

    The aim of this work is to design and study a Balancing Domain Decomposition by Constraints (BDDC) solver for the nonlinear elasticity system modeling the mechanical deformation of cardiac tissue. The contraction–relaxation process in the myocardium is induced by the generation and spread of the bioelectrical excitation throughout the tissue and it is mathematically described by the coupling of cardiac electro-mechanical models consisting of systems of partial and ordinary differential equations. In this study, the discretization of the electro-mechanical models is performed by Q1 finite elements in space and semi-implicit finite difference schemes in time, leading to the solution of a large-scale linear system for the bioelectrical potentials and a nonlinear system for the mechanical deformation at each time step of the simulation. The parallel mechanical solver proposed in this paper consists in solving the nonlinear system with a Newton-Krylov-BDDC method, based on the parallel solution of local mechanical problems and a coarse problem for the so-called primal unknowns. Three-dimensional parallel numerical tests on different machines show that the proposed parallel solver is scalable in the number of subdomains, quasi-optimal in the ratio of subdomain to mesh sizes, and robust with respect to tissue anisotropy.

  20. On a fourth order superlinear elliptic problem

    Directory of Open Access Journals (Sweden)

    M. Ramos

    2001-01-01

    Full Text Available We prove the existence of a nonzero solution for the fourth order elliptic equation $$Delta^2u= mu u +a(xg(u$$ with boundary conditions $u=Delta u=0$. Here, $mu$ is a real parameter, $g$ is superlinear both at zero and infinity and $a(x$ changes sign in $Omega$. The proof uses a variational argument based on the argument by Bahri-Lions cite{BL}.

  1. An Optimized Multicolor Point-Implicit Solver for Unstructured Grid Applications on Graphics Processing Units

    Science.gov (United States)

    Zubair, Mohammad; Nielsen, Eric; Luitjens, Justin; Hammond, Dana

    2016-01-01

    In the field of computational fluid dynamics, the Navier-Stokes equations are often solved using an unstructuredgrid approach to accommodate geometric complexity. Implicit solution methodologies for such spatial discretizations generally require frequent solution of large tightly-coupled systems of block-sparse linear equations. The multicolor point-implicit solver used in the current work typically requires a significant fraction of the overall application run time. In this work, an efficient implementation of the solver for graphics processing units is proposed. Several factors present unique challenges to achieving an efficient implementation in this environment. These include the variable amount of parallelism available in different kernel calls, indirect memory access patterns, low arithmetic intensity, and the requirement to support variable block sizes. In this work, the solver is reformulated to use standard sparse and dense Basic Linear Algebra Subprograms (BLAS) functions. However, numerical experiments show that the performance of the BLAS functions available in existing CUDA libraries is suboptimal for matrices representative of those encountered in actual simulations. Instead, optimized versions of these functions are developed. Depending on block size, the new implementations show performance gains of up to 7x over the existing CUDA library functions.

  2. Galerkin CFD solvers for use in a multi-disciplinary suite for modeling advanced flight vehicles

    Science.gov (United States)

    Moffitt, Nicholas J.

    This work extends existing Galerkin CFD solvers for use in a multi-disciplinary suite. The suite is proposed as a means of modeling advanced flight vehicles, which exhibit strong coupling between aerodynamics, structural dynamics, controls, rigid body motion, propulsion, and heat transfer. Such applications include aeroelastics, aeroacoustics, stability and control, and other highly coupled applications. The suite uses NASA STARS for modeling structural dynamics and heat transfer. Aerodynamics, propulsion, and rigid body dynamics are modeled in one of the five CFD solvers below. Euler2D and Euler3D are Galerkin CFD solvers created at OSU by Cowan (2003). These solvers are capable of modeling compressible inviscid aerodynamics with modal elastics and rigid body motion. This work reorganized these solvers to improve efficiency during editing and at run time. Simple and efficient propulsion models were added, including rocket, turbojet, and scramjet engines. Viscous terms were added to the previous solvers to create NS2D and NS3D. The viscous contributions were demonstrated in the inertial and non-inertial frames. Variable viscosity (Sutherland's equation) and heat transfer boundary conditions were added to both solvers but not verified in this work. Two turbulence models were implemented in NS2D and NS3D: Spalart-Allmarus (SA) model of Deck, et al. (2002) and Menter's SST model (1994). A rotation correction term (Shur, et al., 2000) was added to the production of turbulence. Local time stepping and artificial dissipation were adapted to each model. CFDsol is a Taylor-Galerkin solver with an SA turbulence model. This work improved the time accuracy, far field stability, viscous terms, Sutherland?s equation, and SA model with NS3D as a guideline and added the propulsion models from Euler3D to CFDsol. Simple geometries were demonstrated to utilize current meshing and processing capabilities. Air-breathing hypersonic flight vehicles (AHFVs) represent the ultimate

  3. Simplified Linear Equation Solvers users manual

    Energy Technology Data Exchange (ETDEWEB)

    Gropp, W. [Argonne National Lab., IL (United States); Smith, B. [California Univ., Los Angeles, CA (United States)

    1993-02-01

    The solution of large sparse systems of linear equations is at the heart of many algorithms in scientific computing. The SLES package is a set of easy-to-use yet powerful and extensible routines for solving large sparse linear systems. The design of the package allows new techniques to be used in existing applications without any source code changes in the applications.

  4. The Ellipticity Filter-A Proposed Solution to the Mixed Event Problem in Nuclear Seismic Discrimination

    Science.gov (United States)

    1974-09-07

    ellipticity filter. The source waveforms are recreated by an inverse transform of those complex ampli- tudes associated with the same azimuth...terms of the three complex data points and the ellipticity. Having solved the equations for all frequency bins, the inverse transform of...Transform of those complex amplitudes associated with Source 1, yielding the signal a (t). Similarly, take the inverse Transform of all

  5. Numerical studies of time-independent and time-dependent scattering by several elliptical cylinders

    Science.gov (United States)

    Nigsch, Martin

    2007-07-01

    A numerical solution to the problem of time-dependent scattering by an array of elliptical cylinders with parallel axes is presented. The solution is an exact one, based on the separation-of-variables technique in the elliptical coordinate system, the addition theorem for Mathieu functions, and numerical integration. Time-independent solutions are described by a system of linear equations of infinite order which are truncated for numerical computations. Time-dependent solutions are obtained by numerical integration involving a large number of these solutions. First results of a software package generating these solutions are presented: wave propagation around three impenetrable elliptical scatterers. As far as we know, this method described has never been used for time-dependent multiple scattering.

  6. Convergent Difference Schemes for Hamilton-Jacobi equations

    KAUST Repository

    Duisembay, Serikbolsyn

    2018-01-01

    In this thesis, we consider second-order fully nonlinear partial differential equations of elliptic type. Our aim is to develop computational methods using convergent difference schemes for stationary Hamilton-Jacobi equations with Dirichlet

  7. Elliptical optical solitary waves in a finite nematic liquid crystal cell

    Science.gov (United States)

    Minzoni, Antonmaria A.; Sciberras, Luke W.; Smyth, Noel F.; Worthy, Annette L.

    2015-05-01

    The addition of orbital angular momentum has been previously shown to stabilise beams of elliptic cross-section. In this article the evolution of such elliptical beams is explored through the use of an approximate methodology based on modulation theory. An approximate method is used as the equations that govern the optical system have no known exact solitary wave solution. This study brings to light two distinct phases in the evolution of a beam carrying orbital angular momentum. The two phases are determined by the shedding of radiation in the form of mass loss and angular momentum loss. The first phase is dominated by the shedding of angular momentum loss through spiral waves. The second phase is dominated by diffractive radiation loss which drives the elliptical solitary wave to a steady state. In addition to modulation theory, the "chirp" variational method is also used to study this evolution. Due to the significant role radiation loss plays in the evolution of an elliptical solitary wave, an attempt is made to couple radiation loss to the chirp variational method. This attempt furthers understanding as to why radiation loss cannot be coupled to the chirp method. The basic reason for this is that there is no consistent manner to match the chirp trial function to the generated radiating waves which is uniformly valid in time. Finally, full numerical solutions of the governing equations are compared with solutions obtained using the various variational approximations, with the best agreement achieved with modulation theory due to its ability to include both mass and angular momentum losses to shed diffractive radiation.

  8. Elliptic Preconditioner for Accelerating the Self-Consistent Field Iteration in Kohn--Sham Density Functional Theory

    Energy Technology Data Exchange (ETDEWEB)

    Lin, Lin [Lawrence Berkeley National Lab. (LBNL), Berkeley, CA (United States). Computational Research Division; Yang, Chao [Lawrence Berkeley National Lab. (LBNL), Berkeley, CA (United States). Computational Research Division

    2013-10-28

    We discuss techniques for accelerating the self consistent field (SCF) iteration for solving the Kohn-Sham equations. These techniques are all based on constructing approximations to the inverse of the Jacobian associated with a fixed point map satisfied by the total potential. They can be viewed as preconditioners for a fixed point iteration. We point out different requirements for constructing preconditioners for insulating and metallic systems respectively, and discuss how to construct preconditioners to keep the convergence rate of the fixed point iteration independent of the size of the atomistic system. We propose a new preconditioner that can treat insulating and metallic system in a unified way. The new preconditioner, which we call an elliptic preconditioner, is constructed by solving an elliptic partial differential equation. The elliptic preconditioner is shown to be more effective in accelerating the convergence of a fixed point iteration than the existing approaches for large inhomogeneous systems at low temperature.

  9. High accuracy electromagnetic field solvers for cylindrical waveguides and axisymmetric structures using the finite element method

    International Nuclear Information System (INIS)

    Nelson, E.M.

    1993-12-01

    Some two-dimensional finite element electromagnetic field solvers are described and tested. For TE and TM modes in homogeneous cylindrical waveguides and monopole modes in homogeneous axisymmetric structures, the solvers find approximate solutions to a weak formulation of the wave equation. Second-order isoparametric lagrangian triangular elements represent the field. For multipole modes in axisymmetric structures, the solver finds approximate solutions to a weak form of the curl-curl formulation of Maxwell's equations. Second-order triangular edge elements represent the radial (ρ) and axial (z) components of the field, while a second-order lagrangian basis represents the azimuthal (φ) component of the field weighted by the radius ρ. A reduced set of basis functions is employed for elements touching the axis. With this basis the spurious modes of the curl-curl formulation have zero frequency, so spurious modes are easily distinguished from non-static physical modes. Tests on an annular ring, a pillbox and a sphere indicate the solutions converge rapidly as the mesh is refined. Computed eigenvalues with relative errors of less than a few parts per million are obtained. Boundary conditions for symmetric, periodic and symmetric-periodic structures are discussed and included in the field solver. Boundary conditions for structures with inversion symmetry are also discussed. Special corner elements are described and employed to improve the accuracy of cylindrical waveguide and monopole modes with singular fields at sharp corners. The field solver is applied to three problems: (1) cross-field amplifier slow-wave circuits, (2) a detuned disk-loaded waveguide linear accelerator structure and (3) a 90 degrees overmoded waveguide bend. The detuned accelerator structure is a critical application of this high accuracy field solver. To maintain low long-range wakefields, tight design and manufacturing tolerances are required

  10. An Equation-Type Approach for the Numerical Solution of the Partial Differential Equations Governing Transport Phenomena in Porous Media

    KAUST Repository

    Sun, Shuyu

    2012-06-02

    A new technique for the numerical solution of the partial differential equations governing transport phenomena in porous media is introduced. In this technique, the governing equations as depicted from the physics of the problem are used without extra manipulations. In other words, there is no need to reduce the number of governing equations by some sort of mathematical manipulations. This technique enables the separation of the physics part of the problem and the solver part, which makes coding more robust and could be used in several other applications with little or no modifications (e.g., multi-phase flow in porous media). In this method, one abandons the need to construct the coefficient matrix for the pressure equation. Alternatively, the coefficients are automatically generated within the solver routine. We show examples of using this technique to solving several flow problems in porous media.

  11. An Equation-Type Approach for the Numerical Solution of the Partial Differential Equations Governing Transport Phenomena in Porous Media

    KAUST Repository

    Sun, Shuyu; Salama, Amgad; El-Amin, Mohamed

    2012-01-01

    A new technique for the numerical solution of the partial differential equations governing transport phenomena in porous media is introduced. In this technique, the governing equations as depicted from the physics of the problem are used without extra manipulations. In other words, there is no need to reduce the number of governing equations by some sort of mathematical manipulations. This technique enables the separation of the physics part of the problem and the solver part, which makes coding more robust and could be used in several other applications with little or no modifications (e.g., multi-phase flow in porous media). In this method, one abandons the need to construct the coefficient matrix for the pressure equation. Alternatively, the coefficients are automatically generated within the solver routine. We show examples of using this technique to solving several flow problems in porous media.

  12. Existence of positive solutions to semilinear elliptic problems with ...

    Indian Academy of Sciences (India)

    57

    In mathematical modeling, elliptic partial differential equations are used together with boundary conditions specifying the .... Note that the trace map X ↩→ Lq(∂Ω) is compact for q ∈ [1, 2∗) (see, e.g., [4, ..... [2] Ambrosetti A and Rabinowitz P H, Dual variational methods in critical point theory and applications, J. Functional ...

  13. Computational partial differential equations using Matlab

    CERN Document Server

    Li, Jichun

    2008-01-01

    Brief Overview of Partial Differential Equations The parabolic equations The wave equations The elliptic equations Differential equations in broader areasA quick review of numerical methods for PDEsFinite Difference Methods for Parabolic Equations Introduction Theoretical issues: stability, consistence, and convergence 1-D parabolic equations2-D and 3-D parabolic equationsNumerical examples with MATLAB codesFinite Difference Methods for Hyperbolic Equations IntroductionSome basic difference schemes Dissipation and dispersion errors Extensions to conservation lawsThe second-order hyperbolic PDE

  14. Influence of an SN solver in a fine-mesh neutronics/thermal-hydraulics framework

    International Nuclear Information System (INIS)

    Jareteg, Klas; Vinai, Paolo; Demaziere, Christophe; Sasic, Srdjan

    2015-01-01

    In this paper a study on the influence of a neutron discrete ordinates (S N ) solver within a fine-mesh neutronic/thermal-hydraulic methodology is presented. The methodology consists of coupling a neutronic solver with a single-phase fluid solver, and it is aimed at computing the two fields on a three-dimensional (3D) sub-pin level. The cross-sections needed for the neutron transport equations are pre-generated using a Monte Carlo approach. The coupling is resolved in an iterative manner with full convergence of both fields. A conservative transfer of the full 3D information is achieved, allowing for a proper coupling between the neutronic and the thermal-hydraulic meshes on the finest calculated scales. The discrete ordinates solver is benchmarked against a Monte Carlo reference solution for a two-dimensional (2D) system. The results confirm the need of a high number of ordinates, giving a satisfactory accuracy in k eff and scalar flux profile applying S 16 for 16 energy groups. The coupled framework is used to compare the S N implementation and a solver based on the neutron diffusion approximation for a full 3D system of a quarter of a symmetric, 7x7 array in an infinite lattice setup. In this case, the impact of the discrete ordinates solver shows to be significant for the coupled system, as demonstrated in the calculations of the temperature distributions. (author)

  15. Interrogation of orbital structure by elliptically polarized intense femtosecond laser pulses

    DEFF Research Database (Denmark)

    Abu-Samha, Mahmoud; Madsen, Lars Bojer

    2011-01-01

    We solve the three-dimensional time-dependent Schrödinger equation and present investigations of the imprint of the orbital angular node in photoelectron momentum distributions of an aligned atomic p-type orbital following ionization by an intense elliptically polarized laser pulse of femtosecond...

  16. A new solver for granular avalanche simulation: Indoor experiment verification and field scale case study

    Science.gov (United States)

    Wang, XiaoLiang; Li, JiaChun

    2017-12-01

    A new solver based on the high-resolution scheme with novel treatments of source terms and interface capture for the Savage-Hutter model is developed to simulate granular avalanche flows. The capability to simulate flow spread and deposit processes is verified through indoor experiments of a two-dimensional granular avalanche. Parameter studies show that reduction in bed friction enhances runout efficiency, and that lower earth pressure restraints enlarge the deposit spread. The April 9, 2000, Yigong avalanche in Tibet, China, is simulated as a case study by this new solver. The predicted results, including evolution process, deposit spread, and hazard impacts, generally agree with site observations. It is concluded that the new solver for the Savage-Hutter equation provides a comprehensive software platform for granular avalanche simulation at both experimental and field scales. In particular, the solver can be a valuable tool for providing necessary information for hazard forecasts, disaster mitigation, and countermeasure decisions in mountainous areas.

  17. A Generic High-performance GPU-based Library for PDE solvers

    DEFF Research Database (Denmark)

    Glimberg, Stefan Lemvig; Engsig-Karup, Allan Peter

    , the privilege of high-performance parallel computing is now in principle accessible for many scientific users, no matter their economic resources. Though being highly effective units, GPUs and parallel architectures in general, pose challenges for software developers to utilize their efficiency. Sequential...... legacy codes are not always easily parallelized and the time spent on conversion might not pay o in the end. We present a highly generic C++ library for fast assembling of partial differential equation (PDE) solvers, aiming at utilizing the computational resources of GPUs. The library requires a minimum...... of GPU computing knowledge, while still oering the possibility to customize user-specic solvers at kernel level if desired. Spatial dierential operators are based on matrix free exible order nite dierence approximations. These matrix free operators minimize both memory consumption and main memory access...

  18. Preconditioned conjugate gradient methods for the Navier-Stokes equations

    Science.gov (United States)

    Ajmani, Kumud; Ng, Wing-Fai; Liou, Meng-Sing

    1994-01-01

    A preconditioned Krylov subspace method (GMRES) is used to solve the linear systems of equations formed at each time-integration step of the unsteady, two-dimensional, compressible Navier-Stokes equations of fluid flow. The Navier-Stokes equations are cast in an implicit, upwind finite-volume, flux-split formulation. Several preconditioning techniques are investigated to enhance the efficiency and convergence rate of the implicit solver based on the GMRES algorithm. The superiority of the new solver is established by comparisons with a conventional implicit solver, namely line Gauss-Seidel relaxation (LGSR). Computational test results for low-speed (incompressible flow over a backward-facing step at Mach 0.1), transonic flow (trailing edge flow in a transonic turbine cascade), and hypersonic flow (shock-on-shock interactions on a cylindrical leading edge at Mach 6.0) are presented. For the Mach 0.1 case, overall speedup factors of up to 17 (in terms of time-steps) and 15 (in terms of CPU time on a CRAY-YMP/8) are found in favor of the preconditioned GMRES solver, when compared with the LGSR solver. The corresponding speedup factors for the transonic flow case are 17 and 23, respectively. The hypersonic flow case shows slightly lower speedup factors of 9 and 13, respectively. The study of preconditioners conducted in this research reveals that a new LUSGS-type preconditioner is much more efficient than a conventional incomplete LU-type preconditioner.

  19. Comparison between results of solution of Burgers' equation and Laplace's equation by Galerkin and least-square finite element methods

    Science.gov (United States)

    Adib, Arash; Poorveis, Davood; Mehraban, Farid

    2018-03-01

    In this research, two equations are considered as examples of hyperbolic and elliptic equations. In addition, two finite element methods are applied for solving of these equations. The purpose of this research is the selection of suitable method for solving each of two equations. Burgers' equation is a hyperbolic equation. This equation is a pure advection (without diffusion) equation. This equation is one-dimensional and unsteady. A sudden shock wave is introduced to the model. This wave moves without deformation. In addition, Laplace's equation is an elliptical equation. This equation is steady and two-dimensional. The solution of Laplace's equation in an earth dam is considered. By solution of Laplace's equation, head pressure and the value of seepage in the directions X and Y are calculated in different points of earth dam. At the end, water table is shown in the earth dam. For Burgers' equation, least-square method can show movement of wave with oscillation but Galerkin method can not show it correctly (the best method for solving of the Burgers' equation is discrete space by least-square finite element method and discrete time by forward difference.). For Laplace's equation, Galerkin and least square methods can show water table correctly in earth dam.

  20. Exact solutions to sine-Gordon-type equations

    International Nuclear Information System (INIS)

    Liu Shikuo; Fu Zuntao; Liu Shida

    2006-01-01

    In this Letter, sine-Gordon-type equations, including single sine-Gordon equation, double sine-Gordon equation and triple sine-Gordon equation, are systematically solved by Jacobi elliptic function expansion method. It is shown that different transformations for these three sine-Gordon-type equations play different roles in obtaining exact solutions, some transformations may not work for a specific sine-Gordon equation, while work for other sine-Gordon equations

  1. Structure of stable degeneration of K3 surfaces into pairs of rational elliptic surfaces

    OpenAIRE

    Kimura, Yusuke

    2018-01-01

    F-theory/heterotic duality is formulated in the stable degeneration limit of a K3 fibration on the F-theory side. In this note, we analyze the structure of the stable degeneration limit. We discuss whether stable degeneration exists for pairs of rational elliptic surfaces. We demonstrate that, when two rational elliptic surfaces have an identical complex structure, stable degeneration always exists. We provide an equation that systematically describes the stable degeneration of a K3 surface i...

  2. Mechanism of unconventional aerodynamic characteristics of an elliptic airfoil

    Directory of Open Access Journals (Sweden)

    Sun Wei

    2015-06-01

    Full Text Available The aerodynamic characteristics of elliptic airfoil are quite different from the case of conventional airfoil for Reynolds number varying from about 104 to 106. In order to reveal the fundamental mechanism, the unsteady flow around a stationary two-dimensional elliptic airfoil with 16% relative thickness has been simulated using unsteady Reynolds-averaged Navier–Stokes equations and the γ-Reθt‾ transition turbulence model at different angles of attack for flow Reynolds number of 5 × 105. The aerodynamic coefficients and the pressure distribution obtained by computation are in good agreement with experimental data, which indicates that the numerical method works well. Through this study, the mechanism of the unconventional aerodynamic characteristics of airfoil is analyzed and discussed based on the computational predictions coupled with the wind tunnel results. It is considered that the boundary layer transition at the leading edge and the unsteady flow separation vortices at the trailing edge are the causes of the case. Furthermore, a valuable insight into the physics of how the flow behavior affects the elliptic airfoil’s aerodynamics is provided.

  3. Solving differential–algebraic equation systems by means of index reduction methodology

    DEFF Research Database (Denmark)

    Sørensen, Kim; Houbak, Niels; Condra, Thomas

    2006-01-01

    of a number of differential equations and algebraic equations — a so called DAE system. Two of the DAE systems are of index 1 and they can be solved by means of standard DAE-solvers. For the actual application, the equation systems are integrated by means of MATLAB’s solver: ode23t, that solves moderately...... stiff ODEs and index 1 DAEs by means of the trapezoidal rule. The last sub-model that models the boilers steam drum consist of two differential and three algebraic equations. The index of this model is greater than 1, which means that ode23t cannot integrate this equation system. In this paper......, it is shown how the equation system, by means of an index reduction methodology, can be reduced to a system of ordinary differential equations — ODEs....

  4. Acceleration and higher order schemes of a characteristic solver for the solution of the neutron transport equation in 3D axial geometries

    International Nuclear Information System (INIS)

    Sciannandrone, Daniele

    2015-01-01

    The topic of our research is the application of the Method of Long Characteristics (MOC) to solve the Neutron Transport Equation in three-dimensional axial geometries. The strength of the MOC is in its precision and versatility. As a drawback, it requires a large amount of computational resources. This problem is even more severe in three dimensional geometries, for which unknowns reach the order of tens of billions for assembly-level calculations. The first part of the research has dealt with the development of optimized tracking and reconstruction techniques which take advantage of the regularities of three-dimensional axial geometries. These methods have allowed a strong reduction of the memory requirements and a reduction of the execution time of the MOC calculation. The convergence of the iterative scheme has been accelerated with a lower order transport operator (DPN) which is used for the initialization of the solution and for solving the synthetic problem during MOC iterations. The algorithms for the construction and solution of the MOC and DPN operators have been accelerated by using shared-memory parallel paradigms which are more suitable for standard desktop working stations. An important part of this research has been devoted to the implementation of scheduling techniques to improve the parallel efficiency. The convergence of the angular quadrature formula for three-dimensional cases is also studied. Some of these formulas take advantage of the reduced computational costs of the treatment of planar directions and the vertical direction to speed up the algorithm. The verification of the MOC solver has been done by comparing results with continuous-in-energy Monte Carlo calculations. For this purpose a coupling of the 3D MOC solver with the Subgroup method is proposed to take into account the effects of cross sections resonances. The full calculation of a FBR assembly requires about 2 h of execution time with differences of few pcm with respect to the

  5. Arbitrarily elliptical-cylindrical invisible cloaking

    International Nuclear Information System (INIS)

    Jiang Weixiang; Cui Tiejun; Yu Guanxia; Lin Xianqi; Cheng Qiang; Chin, J Y

    2008-01-01

    Based on the idea of coordinate transformation (Pendry, Schurig and Smith 2006 Science 312 1780), arbitrarily elliptical-cylindrical cloaks are proposed and designed. The elliptical cloak, which is composed of inhomogeneous anisotropic metamaterials in an elliptical-shell region, will deflect incoming electromagnetic (EM) waves and guide them to propagate around the inner elliptical region. Such EM waves will return to their original propagation directions without distorting the waves outside the elliptical cloak. General formulations of the inhomogeneous and anisotropic permittivity and permeability tensors are derived for arbitrarily elliptical axis ratio k, which can also be used for the circular cloak when k = 1. Hence the elliptical cloaks can make a large range of objects invisible, from round objects (when k approaches 1) to long and thin objects (when k is either very large or very small). We also show that the material parameters in elliptical cloaking are singular at only two points, instead of on the whole inner circle for circular cloaking, which are much easier to be realized in actual applications. Full-wave simulations are given to validate the arbitrarily elliptical cloaking

  6. A LAGRANGIAN GAUSS-NEWTON-KRYLOV SOLVER FOR MASS- AND INTENSITY-PRESERVING DIFFEOMORPHIC IMAGE REGISTRATION.

    Science.gov (United States)

    Mang, Andreas; Ruthotto, Lars

    2017-01-01

    We present an efficient solver for diffeomorphic image registration problems in the framework of Large Deformations Diffeomorphic Metric Mappings (LDDMM). We use an optimal control formulation, in which the velocity field of a hyperbolic PDE needs to be found such that the distance between the final state of the system (the transformed/transported template image) and the observation (the reference image) is minimized. Our solver supports both stationary and non-stationary (i.e., transient or time-dependent) velocity fields. As transformation models, we consider both the transport equation (assuming intensities are preserved during the deformation) and the continuity equation (assuming mass-preservation). We consider the reduced form of the optimal control problem and solve the resulting unconstrained optimization problem using a discretize-then-optimize approach. A key contribution is the elimination of the PDE constraint using a Lagrangian hyperbolic PDE solver. Lagrangian methods rely on the concept of characteristic curves. We approximate these curves using a fourth-order Runge-Kutta method. We also present an efficient algorithm for computing the derivatives of the final state of the system with respect to the velocity field. This allows us to use fast Gauss-Newton based methods. We present quickly converging iterative linear solvers using spectral preconditioners that render the overall optimization efficient and scalable. Our method is embedded into the image registration framework FAIR and, thus, supports the most commonly used similarity measures and regularization functionals. We demonstrate the potential of our new approach using several synthetic and real world test problems with up to 14.7 million degrees of freedom.

  7. A new iterative solver for the time-harmonic wave equation

    NARCIS (Netherlands)

    Riyanti, C.D.; Erlangga, Y.A.; Plessix, R.E.; Mulder, W.A.; Vuik, C.; Oosterlee, C.

    2006-01-01

    The time-harmonic wave equation, also known as the Helmholtz equation, is obtained if the constant-density acoustic wave equation is transformed from the time domain to the frequency domain. Its discretization results in a large, sparse, linear system of equations. In two dimensions, this system can

  8. An iterative, fast-sweeping-based eikonal solver for 3D tilted anisotropic media

    KAUST Repository

    Waheed, Umair bin; Yarman, Can Evren; Flagg, Garret

    2015-01-01

    Computation of first-arrival traveltimes for quasi-P waves in the presence of anisotropy is important for high-end near-surface modeling, microseismic-source localization, and fractured-reservoir characterization - and it requires solving an anisotropic eikonal equation. Anisotropy deviating from elliptical anisotropy introduces higher order nonlinearity into the eikonal equation, which makes solving the eikonal equation a challenge. We addressed this challenge by iteratively solving a sequence of simpler tilted elliptically anisotropic eikonal equations. At each iteration, the source function was updated to capture the effects of the higher order nonlinear terms. We used Aitken's extrapolation to speed up convergence rate of the iterative algorithm. The result is an algorithm for computing first-arrival traveltimes in tilted anisotropic media. We evaluated the applicability and usefulness of our method on tilted transversely isotropic media and tilted orthorhombic media. Our numerical tests determined that the proposed method matches the first arrivals obtained by wavefield extrapolation, even for strongly anisotropic and highly complex subsurface structures. Thus, for the cases where two-point ray tracing fails, our method can be a potential substitute for computing traveltimes. The approach presented here can be easily extended to compute first-arrival traveltimes for anisotropic media with lower symmetries, such as monoclinic or even the triclinic media.

  9. An iterative, fast-sweeping-based eikonal solver for 3D tilted anisotropic media

    KAUST Repository

    Waheed, Umair bin

    2015-03-30

    Computation of first-arrival traveltimes for quasi-P waves in the presence of anisotropy is important for high-end near-surface modeling, microseismic-source localization, and fractured-reservoir characterization - and it requires solving an anisotropic eikonal equation. Anisotropy deviating from elliptical anisotropy introduces higher order nonlinearity into the eikonal equation, which makes solving the eikonal equation a challenge. We addressed this challenge by iteratively solving a sequence of simpler tilted elliptically anisotropic eikonal equations. At each iteration, the source function was updated to capture the effects of the higher order nonlinear terms. We used Aitken\\'s extrapolation to speed up convergence rate of the iterative algorithm. The result is an algorithm for computing first-arrival traveltimes in tilted anisotropic media. We evaluated the applicability and usefulness of our method on tilted transversely isotropic media and tilted orthorhombic media. Our numerical tests determined that the proposed method matches the first arrivals obtained by wavefield extrapolation, even for strongly anisotropic and highly complex subsurface structures. Thus, for the cases where two-point ray tracing fails, our method can be a potential substitute for computing traveltimes. The approach presented here can be easily extended to compute first-arrival traveltimes for anisotropic media with lower symmetries, such as monoclinic or even the triclinic media.

  10. A SEMI-LAGRANGIAN TWO-LEVEL PRECONDITIONED NEWTON-KRYLOV SOLVER FOR CONSTRAINED DIFFEOMORPHIC IMAGE REGISTRATION.

    Science.gov (United States)

    Mang, Andreas; Biros, George

    2017-01-01

    We propose an efficient numerical algorithm for the solution of diffeomorphic image registration problems. We use a variational formulation constrained by a partial differential equation (PDE), where the constraints are a scalar transport equation. We use a pseudospectral discretization in space and second-order accurate semi-Lagrangian time stepping scheme for the transport equations. We solve for a stationary velocity field using a preconditioned, globalized, matrix-free Newton-Krylov scheme. We propose and test a two-level Hessian preconditioner. We consider two strategies for inverting the preconditioner on the coarse grid: a nested preconditioned conjugate gradient method (exact solve) and a nested Chebyshev iterative method (inexact solve) with a fixed number of iterations. We test the performance of our solver in different synthetic and real-world two-dimensional application scenarios. We study grid convergence and computational efficiency of our new scheme. We compare the performance of our solver against our initial implementation that uses the same spatial discretization but a standard, explicit, second-order Runge-Kutta scheme for the numerical time integration of the transport equations and a single-level preconditioner. Our improved scheme delivers significant speedups over our original implementation. As a highlight, we observe a 20 × speedup for a two dimensional, real world multi-subject medical image registration problem.

  11. Experimental Validation of Elliptical Fin-Opening Behavior

    Directory of Open Access Journals (Sweden)

    James M. Garner

    2003-01-01

    Full Text Available An effort to improve the performance of ordnance has led to the consideration of the use of folding elliptical fins for projectile stabilization. A second order differential equation was used to model elliptical fin deployment history and accounts for: deployment with respect to the geometric properties of the fin, the variation in fin aerodynamics during deployment, the initial yaw effect on fin opening, and the variation in deployment speed based on changes in projectile spin. This model supports tests conducted at the Transonic Experimental Facility, Aberdeen Proving Ground examining the opening behavior of these uniquely shaped fins. The fins use the centrifugal force from the projectile spin to deploy. During the deployment, the fin aerodynamic forces vary with angle-of-attack changes to the free stream. Model results indicate that projectile spin dominates the initial opening rates and aerodynamics dominate near the fully open state. The model results are examined to explain the observed behaviors, and suggest improvements for later designs.

  12. Solving differential-algebraic equation systems by means of index reduction methodology

    DEFF Research Database (Denmark)

    Sørensen, Kim; Houbak, Niels; Condra, Thomas Joseph

    2006-01-01

    of a number of differential equations and algebraic equations - a so called DAE system. Two of the DAE systems are of index 1 and they can be solved by means of standard DAE-solvers. For the actual application, the equation systems are integrated by means of MATLAB’s solver: ode23t, that solves moderately...... stiff ODE’s and index 1 DAE’s by means of the trapezoidal rule. The last sub-model that models the boilers steam drum consist of two differential and three algebraic equations. The index of this model is greater than 1, which means that ode23t cannot integrate this equation system. In this paper......, it is shown how the equation system, by means of an index reduction methodology, can be reduced to a system of Ordinary- Differential-Equations - ODE’s....

  13. Electromagnetic design of a β=0.9, 650 MHz elliptic superconducting radio frequency cavity

    International Nuclear Information System (INIS)

    Jana, Arup Ratan; Kumar, V.

    2011-01-01

    We have recently performed two-dimensional (2D) electromagnetic design studies of a β=0.9, 650 MHz, elliptic superconducting radio frequency (SCRF) cavity using electromagnetic field solver code SUPERFISH. We have evolved the design starting from the design parameters of β=1, 1300 MHz, TESLA design SCRF cavity and then scaled it for the β=0.9 and 650 MHz case. The design has been optimized for minimizing the SCRF cavity power loss. One of the important parameters in the design of such elliptic SCRF cavities is the wall angle, which is defined as the vertical angle made by the common tangent to the iris and equator ellipses. Generally, there is a constraint on the minimum value of the wall angle, which is decided by the mechanical considerations, ease of chemical cleaning etc. In our optimization studies, we have first explored the case when there is no such constraint on wall angle. We find that from the point of view of low cavity power dissipation, the optimized design has a re-entrant geometry, where the wall angle is negative. We then perform design optimization, keeping the constraint that the wall angle should be greater than 5 degree. Keeping this constraint, we find that our optimized design parameters for the single cell match closely with the design parameters reported for Project-X. We discuss the results of 2D electromagnetic field calculations for this design using SUPERFISH. In the next, we have performed the design studies of the multi-cell β=0.9, 650 MHz, elliptic SCRF cavity. The design parameters of end-cells are optimized such that the frequency of the end-cell is matched to that of mid-cells. We have studied all the normal modes for the multi-cell cavity. The frequency of different normal modes is also calculated using a finite element code ANSYS and results are compared with those obtained using SUPERFISH. The field flatness, which is an important design criterion, is also studied. For multi-cell cavity, another important aspect is the cell

  14. Surfaces immersed in Lie algebras associated with elliptic integrals

    International Nuclear Information System (INIS)

    Grundland, A M; Post, S

    2012-01-01

    The objective of this work is to adapt the Fokas–Gel’fand immersion formula to ordinary differential equations written in the Lax representation. The formalism of generalized vector fields and their prolongation structure is employed to establish necessary and sufficient conditions for the existence and integration of immersion functions for surfaces in Lie algebras. As an example, a class of second-order, integrable, ordinary differential equations is considered and the most general solutions for the wavefunctions of the linear spectral problem are found. Several explicit examples of surfaces associated with Jacobian and P-Weierstrass elliptic functions are presented. (paper)

  15. PUFoam : A novel open-source CFD solver for the simulation of polyurethane foams

    Science.gov (United States)

    Karimi, M.; Droghetti, H.; Marchisio, D. L.

    2017-08-01

    In this work a transient three-dimensional mathematical model is formulated and validated for the simulation of polyurethane (PU) foams. The model is based on computational fluid dynamics (CFD) and is coupled with a population balance equation (PBE) to describe the evolution of the gas bubbles/cells within the PU foam. The front face of the expanding foam is monitored on the basis of the volume-of-fluid (VOF) method using a compressible solver available in OpenFOAM version 3.0.1. The solver is additionally supplemented to include the PBE, solved with the quadrature method of moments (QMOM), the polymerization kinetics, an adequate rheological model and a simple model for the foam thermal conductivity. The new solver is labelled as PUFoam and is, for the first time in this work, validated for 12 different mixing-cup experiments. Comparison of the time evolution of the predicted and experimentally measured density and temperature of the PU foam shows the potentials and limitations of the approach.

  16. Computational aeroelasticity using a pressure-based solver

    Science.gov (United States)

    Kamakoti, Ramji

    A computational methodology for performing fluid-structure interaction computations for three-dimensional elastic wing geometries is presented. The flow solver used is based on an unsteady Reynolds-Averaged Navier-Stokes (RANS) model. A well validated k-ε turbulence model with wall function treatment for near wall region was used to perform turbulent flow calculations. Relative merits of alternative flow solvers were investigated. The predictor-corrector-based Pressure Implicit Splitting of Operators (PISO) algorithm was found to be computationally economic for unsteady flow computations. Wing structure was modeled using Bernoulli-Euler beam theory. A fully implicit time-marching scheme (using the Newmark integration method) was used to integrate the equations of motion for structure. Bilinear interpolation and linear extrapolation techniques were used to transfer necessary information between fluid and structure solvers. Geometry deformation was accounted for by using a moving boundary module. The moving grid capability was based on a master/slave concept and transfinite interpolation techniques. Since computations were performed on a moving mesh system, the geometric conservation law must be preserved. This is achieved by appropriately evaluating the Jacobian values associated with each cell. Accurate computation of contravariant velocities for unsteady flows using the momentum interpolation method on collocated, curvilinear grids was also addressed. Flutter computations were performed for the AGARD 445.6 wing at subsonic, transonic and supersonic Mach numbers. Unsteady computations were performed at various dynamic pressures to predict the flutter boundary. Results showed favorable agreement of experiment and previous numerical results. The computational methodology exhibited capabilities to predict both qualitative and quantitative features of aeroelasticity.

  17. Elliptic net and its cryptographic application

    Science.gov (United States)

    Muslim, Norliana; Said, Mohamad Rushdan Md

    2017-11-01

    Elliptic net is a generalization of elliptic divisibility sequence and in cryptography field, most cryptographic pairings that are based on elliptic curve such as Tate pairing can be improved by applying elliptic nets algorithm. The elliptic net is constructed by using n dimensional array of values in rational number satisfying nonlinear recurrence relations that arise from elliptic divisibility sequences. The two main properties hold in the recurrence relations are for all positive integers m>n, hm +nhm -n=hm +1hm -1hn2-hn +1hn -1hm2 and hn divides hm whenever n divides m. In this research, we discuss elliptic divisibility sequence associated with elliptic nets based on cryptographic perspective and its possible research direction.

  18. Dirac equations for generalised Yang-Mills systems

    International Nuclear Information System (INIS)

    Lechtenfeld, O.; Nahm, W.; Tchrakian, D.H.

    1985-06-01

    We present Dirac equations in 4p dimensions for the generalised Yang-Mills (GYM) theories introduced earlier. These Dirac equations are related to the self-duality equations of the GYM and are checked to be elliptic in a 'BPST' background. In this background these Dirac equations are integrated exactly. The possibility of imposing supersymmetry in the GYM-Dirac system is investigated, with negative results. (orig.)

  19. Iterative linear solvers in a 2D radiation-hydrodynamics code: Methods and performance

    International Nuclear Information System (INIS)

    Baldwin, C.; Brown, P.N.; Falgout, R.; Graziani, F.; Jones, J.

    1999-01-01

    Computer codes containing both hydrodynamics and radiation play a central role in simulating both astrophysical and inertial confinement fusion (ICF) phenomena. A crucial aspect of these codes is that they require an implicit solution of the radiation diffusion equations. The authors present in this paper the results of a comparison of five different linear solvers on a range of complex radiation and radiation-hydrodynamics problems. The linear solvers used are diagonally scaled conjugate gradient, GMRES with incomplete LU preconditioning, conjugate gradient with incomplete Cholesky preconditioning, multigrid, and multigrid-preconditioned conjugate gradient. These problems involve shock propagation, opacities varying over 5--6 orders of magnitude, tabular equations of state, and dynamic ALE (Arbitrary Lagrangian Eulerian) meshes. They perform a problem size scalability study by comparing linear solver performance over a wide range of problem sizes from 1,000 to 100,000 zones. The fundamental question they address in this paper is: Is it more efficient to invert the matrix in many inexpensive steps (like diagonally scaled conjugate gradient) or in fewer expensive steps (like multigrid)? In addition, what is the answer to this question as a function of problem size and is the answer problem dependent? They find that the diagonally scaled conjugate gradient method performs poorly with the growth of problem size, increasing in both iteration count and overall CPU time with the size of the problem and also increasing for larger time steps. For all problems considered, the multigrid algorithms scale almost perfectly (i.e., the iteration count is approximately independent of problem size and problem time step). For pure radiation flow problems (i.e., no hydrodynamics), they see speedups in CPU time of factors of ∼15--30 for the largest problems, when comparing the multigrid solvers relative to diagonal scaled conjugate gradient

  20. Modelling the Inflation of Polyisobutylene Into an Elliptic and a Circular Cylinder

    DEFF Research Database (Denmark)

    Rasmussen, Henrik Koblitz; Gøttsche, Søren; Kjær, Erik Michael

    2000-01-01

    The isothermal inflation of a sheet of a Polyisobutylene melt into a circular and an elliptic cylinder is modelled using the 3D Lagrangian Integral Method. The non-linear properties of the Polyisobutylene are modelled with the Factorized K-BKZ constitutive equation, using a potential function bas...

  1. LSODKR, Stiff Ordinary Differential Equations (ODE) System Solver with Krylov Iteration and Root-finding

    International Nuclear Information System (INIS)

    Hindmarsh, A.D.; Brown, P.N.

    1996-01-01

    1 - Description of program or function: LSODKR is a new initial value ODE solver for stiff and non-stiff systems. It is a variant of the LSODPK and LSODE solvers, intended mainly for large stiff systems. The main differences between LSODKR and LSODE are the following: a) for stiff systems, LSODKR uses a corrector iteration composed of Newton iteration and one of four preconditioned Krylov subspace iteration methods. The user must supply routines for the preconditioning operations, b) within the corrector iteration, LSODKR does automatic switching between functional (fix point) iteration and modified Newton iteration, c) LSODKR includes the ability to find roots of given functions of the solution during the integration. 2 - Method of solution: Integration is by Adams or BDF (Backward Differentiation Formula) methods, at user option. Corrector iteration is by Newton or fix point iteration, determined dynamically. Linear system solution is by a preconditioned Krylov iteration, selected by user from Incomplete Orthogonalization Method, Generalized Minimum Residual Method, and two variants of Preconditioned Conjugate Gradient Method. Preconditioning is to be supplied by the user. 3 - Restrictions on the complexity of the problem: None

  2. Iterative solvers in forming process simulations

    NARCIS (Netherlands)

    van den Boogaard, Antonius H.; Rietman, Bert; Huetink, Han

    1998-01-01

    The use of iterative solvers in implicit forming process simulations is studied. The time and memory requirements are compared with direct solvers and assessed in relation with the rest of the Newton-Raphson iteration process. It is shown that conjugate gradient{like solvers with a proper

  3. Simple Navier’s slip boundary condition for the non-Newtonian Lattice Boltzmann fluid dynamics solver

    DEFF Research Database (Denmark)

    Svec, Oldrich; Skoček, Jan

    2013-01-01

    The ability of the Lattice Boltzmann method, as the fluid dynamics solver, to properly simulate macroscopic Navier’s slip boundary condition is investigated. An approximate equation relating the Lattice Boltzmann variable slip boundary condition with the macroscopic Navier’s slip boundary condition...

  4. Modeling Microbunching from Shot Noise Using Vlasov Solvers

    International Nuclear Information System (INIS)

    Venturini, Marco; Venturini, Marco; Zholents, Alexander

    2008-01-01

    Unlike macroparticle simulations, which are sensitive to unphysical statistical fluctuations when the number of macroparticles is smaller than the bunch population, direct methods for solving the Vlasov equation are free from sampling noise and are ideally suited for studying microbunching instabilities evolving from shot noise. We review a 2D (longitudinal dynamics) Vlasov solver we have recently developed to study the microbunching instability in the beam delivery systems for x-ray FELs and present an application to FERMI(at)Elettra. We discuss, in particular, the impact of the spreader design on microbunching

  5. Development of an Analytic Nodal Diffusion Solver in Multi-groups for 3D Reactor Cores with Rectangular or Hexagonal Assemblies

    Energy Technology Data Exchange (ETDEWEB)

    Lozano, Juan Andres; Aragones, Jose Maria; Garcia-Herranz, Nuria [Universidad Politecnica de Madrid, 28006 Jose Gutierrez Abascal 2, Madrid (Spain)

    2008-07-01

    More accurate modelling of physical phenomena involved in present and future nuclear reactors requires a multi-scale and multi-physics approach. This challenge can be accomplished by the coupling of best-estimate core-physics, thermal-hydraulics and multi-physics solvers. In order to make viable that coupling, the current trends in reactor simulations are along the development of a new generation of tools based on user-friendly, modular, easily linkable, faster and more accurate codes to be integrated in common platforms. These premises are in the origin of the NURESIM Integrated Project within the 6. European Framework Program, which is envisaged to provide the initial step towards a Common European Standard Software Platform for nuclear reactors simulations. In the frame of this project and to reach the above-mentioned goals, a 3-D multigroup nodal solver for neutron diffusion calculations called ANDES (Analytic Nodal Diffusion Equation Solver) has been developed and tested in-depth in this Thesis. ANDES solves the steady-state and time-dependent neutron diffusion equation in three-dimensions and any number of energy groups, utilizing the Analytic Coarse-Mesh Finite-Difference (ACMFD) scheme to yield the nodal coupling equations. It can be applied to both Cartesian and triangular-Z geometries, so that simulations of LWR as well as VVER, HTR and fast reactors can be performed. The solver has been implemented in a fully encapsulated way, enabling it as a module to be readily integrated in other codes and platforms. In fact, it can be used either as a stand-alone nodal code or as a solver to accelerate the convergence of whole core pin-by-pin code systems. Verification of performance has shown that ANDES is a code with high order definition for whole core realistic nodal simulations. In this paper, the methodology developed and involved in ANDES is presented. (authors)

  6. Final Report for 'Implimentation and Evaluation of Multigrid Linear Solvers into Extended Magnetohydrodynamic Codes for Petascale Computing'

    International Nuclear Information System (INIS)

    Vadlamani, Srinath; Kruger, Scott; Austin, Travis

    2008-01-01

    Extended magnetohydrodynamic (MHD) codes are used to model the large, slow-growing instabilities that are projected to limit the performance of International Thermonuclear Experimental Reactor (ITER). The multiscale nature of the extended MHD equations requires an implicit approach. The current linear solvers needed for the implicit algorithm scale poorly because the resultant matrices are so ill-conditioned. A new solver is needed, especially one that scales to the petascale. The most successful scalable parallel processor solvers to date are multigrid solvers. Applying multigrid techniques to a set of equations whose fundamental modes are dispersive waves is a promising solution to CEMM problems. For the Phase 1, we implemented multigrid preconditioners from the HYPRE project of the Center for Applied Scientific Computing at LLNL via PETSc of the DOE SciDAC TOPS for the real matrix systems of the extended MHD code NIMROD which is a one of the primary modeling codes of the OFES-funded Center for Extended Magnetohydrodynamic Modeling (CEMM) SciDAC. We implemented the multigrid solvers on the fusion test problem that allows for real matrix systems with success, and in the process learned about the details of NIMROD data structures and the difficulties of inverting NIMROD operators. The further success of this project will allow for efficient usage of future petascale computers at the National Leadership Facilities: Oak Ridge National Laboratory, Argonne National Laboratory, and National Energy Research Scientific Computing Center. The project will be a collaborative effort between computational plasma physicists and applied mathematicians at Tech-X Corporation, applied mathematicians Front Range Scientific Computations, Inc. (who are collaborators on the HYPRE project), and other computational plasma physicists involved with the CEMM project.

  7. The Laguerre finite difference one-way equation solver

    Science.gov (United States)

    Terekhov, Andrew V.

    2017-05-01

    This paper presents a new finite difference algorithm for solving the 2D one-way wave equation with a preliminary approximation of a pseudo-differential operator by a system of partial differential equations. As opposed to the existing approaches, the integral Laguerre transform instead of Fourier transform is used. After carrying out the approximation of spatial variables it is possible to obtain systems of linear algebraic equations with better computing properties and to reduce computer costs for their solution. High accuracy of calculations is attained at the expense of employing finite difference approximations of higher accuracy order that are based on the dispersion-relationship-preserving method and the Richardson extrapolation in the downward continuation direction. The numerical experiments have verified that as compared to the spectral difference method based on Fourier transform, the new algorithm allows one to calculate wave fields with a higher degree of accuracy and a lower level of numerical noise and artifacts including those for non-smooth velocity models. In the context of solving the geophysical problem the post-stack migration for velocity models of the types Syncline and Sigsbee2A has been carried out. It is shown that the images obtained contain lesser noise and are considerably better focused as compared to those obtained by the known Fourier Finite Difference and Phase-Shift Plus Interpolation methods. There is an opinion that purely finite difference approaches do not allow carrying out the seismic migration procedure with sufficient accuracy, however the results obtained disprove this statement. For the supercomputer implementation it is proposed to use the parallel dichotomy algorithm when solving systems of linear algebraic equations with block-tridiagonal matrices.

  8. On several aspects and applications of the multigrid method for solving partial differential equations

    Science.gov (United States)

    Dinar, N.

    1978-01-01

    Several aspects of multigrid methods are briefly described. The main subjects include the development of very efficient multigrid algorithms for systems of elliptic equations (Cauchy-Riemann, Stokes, Navier-Stokes), as well as the development of control and prediction tools (based on local mode Fourier analysis), used to analyze, check and improve these algorithms. Preliminary research on multigrid algorithms for time dependent parabolic equations is also described. Improvements in existing multigrid processes and algorithms for elliptic equations were studied.

  9. Effects of mean-field and softening of equation of state on elliptic flow in Au+Au collisions at \\sqrt{{s}_{\\rm{NN}}}=5\\,{GeV} from the JAM model

    Science.gov (United States)

    Chen, Jiamin; Luo, Xiaofeng; Liu, Feng; Nara, Yasushi

    2018-01-01

    We perform a systematic study of elliptic flow (v 2) in Au+Au collisions at \\sqrt{{s}NN}}=5 {GeV} by using a microscopic transport model, JAM. The centrality, pseudorapidity, transverse momentum and beam energy dependence of v 2 for charged as well as identified hadrons are studied. We investigate the effects of both the hadronic mean-field and the softening of equation of state (EoS) on elliptic flow. The softening of the EoS is realized by imposing attractive orbits in two body scattering, which can reduce the pressure of the system. We found that the softening of the EoS leads to the enhancement of v 2, while the hadronic mean-field suppresses v 2 relative to the cascade mode. It indicates that elliptic flow at high baryon density regions is highly sensitive to the EoS and the enhancement of v 2 may probe the signature of a first-order phase transition in heavy-ion collisions at beam energies of a strong baryon stopping region. Supported by the MoST of China 973-Project (2015CB856901), NSFC (11575069, 11221504). Y. N. is supported by the Grants-in-Aid for Scientific Research from JSPS (15K05079, 15K05098)

  10. A Wavelet-Enhanced PWTD-Accelerated Time-Domain Integral Equation Solver for Analysis of Transient Scattering from Electrically Large Conducting Objects

    KAUST Repository

    Liu, Yang

    2018-02-26

    A wavelet-enhanced plane-wave time-domain (PWTD) algorithm for efficiently and accurately solving time-domain surface integral equations (TD-SIEs) on electrically large conducting objects is presented. The proposed scheme reduces the memory requirement and computational cost of the PWTD algorithm by representing the PWTD ray data using local cosine wavelet bases (LCBs) and performing PWTD operations in the wavelet domain. The memory requirement and computational cost of the LCB-enhanced PWTD-accelerated TD-SIE solver, when applied to the analysis of transient scattering from smooth quasi-planar objects with near-normal incident pulses, scale nearly as O(Ns log Ns) and O(Ns 1.5 ), respectively. Here, Ns denotes the number of spatial unknowns. The efficiency and accuracy of the proposed scheme are demonstrated through its applications to the analysis of transient scattering from a 185 wave-length-long NASA almond and a 123-wavelength long Air-bus-A320 model.

  11. Positive solutions with changing sign energy to a nonhomogeneous elliptic problem of fourth order

    Directory of Open Access Journals (Sweden)

    M.Talbi

    2011-01-01

    Full Text Available In this paper, we study the existence for two positive solutions toa nonhomogeneous elliptic equation of fourth order with a parameter lambda such tha 0 < lambda < lambda^. The first solution has a negative energy while the energy of the second one is positive for 0 < lambda < lambda_0 and negative for lambda_0 < lambda < lambda^. The values lambda_0 and lambda^ are given under variational form and we show that every corresponding critical point is solution of the nonlinear elliptic problem (with a suitable multiplicative term.

  12. DL_MG: A Parallel Multigrid Poisson and Poisson-Boltzmann Solver for Electronic Structure Calculations in Vacuum and Solution.

    Science.gov (United States)

    Womack, James C; Anton, Lucian; Dziedzic, Jacek; Hasnip, Phil J; Probert, Matt I J; Skylaris, Chris-Kriton

    2018-03-13

    The solution of the Poisson equation is a crucial step in electronic structure calculations, yielding the electrostatic potential-a key component of the quantum mechanical Hamiltonian. In recent decades, theoretical advances and increases in computer performance have made it possible to simulate the electronic structure of extended systems in complex environments. This requires the solution of more complicated variants of the Poisson equation, featuring nonhomogeneous dielectric permittivities, ionic concentrations with nonlinear dependencies, and diverse boundary conditions. The analytic solutions generally used to solve the Poisson equation in vacuum (or with homogeneous permittivity) are not applicable in these circumstances, and numerical methods must be used. In this work, we present DL_MG, a flexible, scalable, and accurate solver library, developed specifically to tackle the challenges of solving the Poisson equation in modern large-scale electronic structure calculations on parallel computers. Our solver is based on the multigrid approach and uses an iterative high-order defect correction method to improve the accuracy of solutions. Using two chemically relevant model systems, we tested the accuracy and computational performance of DL_MG when solving the generalized Poisson and Poisson-Boltzmann equations, demonstrating excellent agreement with analytic solutions and efficient scaling to ∼10 9 unknowns and 100s of CPU cores. We also applied DL_MG in actual large-scale electronic structure calculations, using the ONETEP linear-scaling electronic structure package to study a 2615 atom protein-ligand complex with routinely available computational resources. In these calculations, the overall execution time with DL_MG was not significantly greater than the time required for calculations using a conventional FFT-based solver.

  13. Acceleration of the OpenFOAM-based MHD solver using graphics processing units

    International Nuclear Information System (INIS)

    He, Qingyun; Chen, Hongli; Feng, Jingchao

    2015-01-01

    Highlights: • A 3D PISO-MHD was implemented on Kepler-class graphics processing units (GPUs) using CUDA technology. • A consistent and conservative scheme is used in the code which was validated by three basic benchmarks in a rectangular and round ducts. • Parallelized of CPU and GPU acceleration were compared relating to single core CPU in MHD problems and non-MHD problems. • Different preconditions for solving MHD solver were compared and the results showed that AMG method is better for calculations. - Abstract: The pressure-implicit with splitting of operators (PISO) magnetohydrodynamics MHD solver of the couple of Navier–Stokes equations and Maxwell equations was implemented on Kepler-class graphics processing units (GPUs) using the CUDA technology. The solver is developed on open source code OpenFOAM based on consistent and conservative scheme which is suitable for simulating MHD flow under strong magnetic field in fusion liquid metal blanket with structured or unstructured mesh. We verified the validity of the implementation on several standard cases including the benchmark I of Shercliff and Hunt's cases, benchmark II of fully developed circular pipe MHD flow cases and benchmark III of KIT experimental case. Computational performance of the GPU implementation was examined by comparing its double precision run times with those of essentially the same algorithms and meshes. The resulted showed that a GPU (GTX 770) can outperform a server-class 4-core, 8-thread CPU (Intel Core i7-4770k) by a factor of 2 at least.

  14. Acceleration of the OpenFOAM-based MHD solver using graphics processing units

    Energy Technology Data Exchange (ETDEWEB)

    He, Qingyun; Chen, Hongli, E-mail: hlchen1@ustc.edu.cn; Feng, Jingchao

    2015-12-15

    Highlights: • A 3D PISO-MHD was implemented on Kepler-class graphics processing units (GPUs) using CUDA technology. • A consistent and conservative scheme is used in the code which was validated by three basic benchmarks in a rectangular and round ducts. • Parallelized of CPU and GPU acceleration were compared relating to single core CPU in MHD problems and non-MHD problems. • Different preconditions for solving MHD solver were compared and the results showed that AMG method is better for calculations. - Abstract: The pressure-implicit with splitting of operators (PISO) magnetohydrodynamics MHD solver of the couple of Navier–Stokes equations and Maxwell equations was implemented on Kepler-class graphics processing units (GPUs) using the CUDA technology. The solver is developed on open source code OpenFOAM based on consistent and conservative scheme which is suitable for simulating MHD flow under strong magnetic field in fusion liquid metal blanket with structured or unstructured mesh. We verified the validity of the implementation on several standard cases including the benchmark I of Shercliff and Hunt's cases, benchmark II of fully developed circular pipe MHD flow cases and benchmark III of KIT experimental case. Computational performance of the GPU implementation was examined by comparing its double precision run times with those of essentially the same algorithms and meshes. The resulted showed that a GPU (GTX 770) can outperform a server-class 4-core, 8-thread CPU (Intel Core i7-4770k) by a factor of 2 at least.

  15. GeN-Foam: a novel OpenFOAM"® based multi-physics solver for 2D/3D transient analysis of nuclear reactors

    International Nuclear Information System (INIS)

    Fiorina, Carlo; Clifford, Ivor; Aufiero, Manuele; Mikityuk, Konstantin

    2015-01-01

    Highlights: • Development of a new multi-physics solver based on OpenFOAM"®. • Tight coupling of thermal-hydraulics, thermal-mechanics and neutronics. • Combined use of traditional RANS and porous-medium models. • Mesh for neutronics deformed according to the predicted displacement field. • Use of three unstructured meshes, adaptive time step, parallel computing. - Abstract: The FAST group at the Paul Scherrer Institut has been developing a code system for reactor analysis for many years. For transient analysis, this code system is currently based on a state-of-the-art coupled TRACE-PARCS routine. This work presents an attempt to supplement the FAST code system with a novel solver characterized by tight coupling between the different equations, parallel computing capabilities, adaptive time-stepping and more accurate treatment of some of the phenomena involved in a reactor transient. The new solver is based on OpenFOAM"®, an open-source C++ library for the solution of partial differential equations using finite-volume discretization. It couples together a multi-scale fine/coarse mesh sub-solver for thermal-hydraulics, a multi-group diffusion sub-solver for neutronics, a displacement-based sub-solver for thermal-mechanics and a finite-difference model for the temperature field in the fuel. It is targeted toward the analysis of pin-based reactors (e.g., liquid metal fast reactors or light water reactors) or homogeneous reactors (e.g., fast-spectrum molten salt reactors). This paper presents each “single-physics” sub-solver and the overall coupling strategy, using the sodium-cooled fast reactor as a test case, and essential code verification tests are described.

  16. Mixed Precision Solver Scalable to 16000 MPI Processes for Lattice Quantum Chromodynamics Simulations on the Oakforest-PACS System

    OpenAIRE

    Boku, Taisuke; Ishikawa, Ken-Ichi; Kuramashi, Yoshinobu; Meadows, Lawrence

    2017-01-01

    Lattice Quantum Chromodynamics (Lattice QCD) is a quantum field theory on a finite discretized space-time box so as to numerically compute the dynamics of quarks and gluons to explore the nature of subatomic world. Solving the equation of motion of quarks (quark solver) is the most compute-intensive part of the lattice QCD simulations and is one of the legacy HPC applications. We have developed a mixed-precision quark solver for a large Intel Xeon Phi (KNL) system named "Oakforest-PACS", empl...

  17. Nonlinear scalar field equations. Pt. 1

    International Nuclear Information System (INIS)

    Berestycki, H.; Lions, P.L.

    1983-01-01

    This paper as well as a subsequent one is concerned with the existence of nontrivial solutions for some semi-linear elliptic equations in Rsup(N). Such problems are motivated in particular by the search for certain kinds of solitary waves (stationary states) in nonlinear equations of the Klein-Gordon or Schroedinger type. (orig./HSI)

  18. Differential equations inverse and direct problems

    CERN Document Server

    Favini, Angelo

    2006-01-01

    DEGENERATE FIRST ORDER IDENTIFICATION PROBLEMS IN BANACH SPACES A NONISOTHERMAL DYNAMICAL GINZBURG-LANDAU MODEL OF SUPERCONDUCTIVITY. EXISTENCE AND UNIQUENESS THEOREMSSOME GLOBAL IN TIME RESULTS FOR INTEGRODIFFERENTIAL PARABOLIC INVERSE PROBLEMSFOURTH ORDER ORDINARY DIFFERENTIAL OPERATORS WITH GENERAL WENTZELL BOUNDARY CONDITIONSTUDY OF ELLIPTIC DIFFERENTIAL EQUATIONS IN UMD SPACESDEGENERATE INTEGRODIFFERENTIAL EQUATIONS OF PARABOLIC TYPE EXPONENTIAL ATTRACTORS FOR SEMICONDUCTOR EQUATIONSCONVERGENCE TO STATIONARY STATES OF SOLUTIONS TO THE SEMILINEAR EQUATION OF VISCOELASTICITY ASYMPTOTIC BEHA

  19. The equations of motion of a secularly precessing elliptical orbit

    Science.gov (United States)

    Casotto, S.; Bardella, M.

    2013-01-01

    The equations of motion of a secularly precessing ellipse are developed using time as the independent variable. The equations are useful when integrating numerically the perturbations about a reference trajectory which is subject to secular perturbations in the node, the argument of pericentre and the mean motion. Usually this is done in connection with Encke's method to ensure minimal rectification frequency. Similar equations are already available in the literature, but they are either given based on the true anomaly as the independent variable or in mixed mode with respect to time through the use of a supporting equation to track the anomaly. The equations developed here form a complete and independent set of six equations in time. Reformulations both of Escobal's and Kyner and Bennett's equations are also provided which lead to a more concise form.

  20. Triaxiality in elliptical galaxies

    Energy Technology Data Exchange (ETDEWEB)

    Benacchio, L; Galletta, G [Padua Univ. (Italy). Ist. di Astronomia

    1980-12-01

    The existence of a triaxial shape for elliptical galaxies has been considered in recent years to explain the new kinematical and geometrical findings, i.e. (a) the low rotation/velocity dispersion ratio found also in some flat systems, (b) the presence of twisting in the isophotes, (c) the recently found correlation between maximum twisting and maximum flattening, (d) the presence of rotation along the minor axis. A simple geometrical model of elliptical galaxies having shells with different axial ratios c/a, b/a has been produced to interpret three fundamental key-features of elliptical galaxies: (i) the distribution of the maximum flattening observed; (ii) the percentage of ellipticals showing twisting; and (iii) the correlation between maximum twisting and maximum flattening. The model has been compared with observational data for 348 elliptical systems as given by Strom and Strom. It is found that a triaxial ellipsoid with coaxial shells having axial ratios c/a and b/a mutually dependent in a linear way can satisfy the observations.

  1. Partial differential equations

    CERN Document Server

    Evans, Lawrence C

    2010-01-01

    This text gives a comprehensive survey of modern techniques in the theoretical study of partial differential equations (PDEs) with particular emphasis on nonlinear equations. The exposition is divided into three parts: representation formulas for solutions; theory for linear partial differential equations; and theory for nonlinear partial differential equations. Included are complete treatments of the method of characteristics; energy methods within Sobolev spaces; regularity for second-order elliptic, parabolic, and hyperbolic equations; maximum principles; the multidimensional calculus of variations; viscosity solutions of Hamilton-Jacobi equations; shock waves and entropy criteria for conservation laws; and, much more.The author summarizes the relevant mathematics required to understand current research in PDEs, especially nonlinear PDEs. While he has reworked and simplified much of the classical theory (particularly the method of characteristics), he primarily emphasizes the modern interplay between funct...

  2. Partial differential equations with variable exponents variational methods and qualitative analysis

    CERN Document Server

    Radulescu, Vicentiu D

    2015-01-01

    Partial Differential Equations with Variable Exponents: Variational Methods and Qualitative Analysis provides researchers and graduate students with a thorough introduction to the theory of nonlinear partial differential equations (PDEs) with a variable exponent, particularly those of elliptic type. The book presents the most important variational methods for elliptic PDEs described by nonhomogeneous differential operators and containing one or more power-type nonlinearities with a variable exponent. The authors give a systematic treatment of the basic mathematical theory and constructive meth

  3. Development and verification of the neutron diffusion solver for the GeN-Foam multi-physics platform

    International Nuclear Information System (INIS)

    Fiorina, Carlo; Kerkar, Nordine; Mikityuk, Konstantin; Rubiolo, Pablo; Pautz, Andreas

    2016-01-01

    Highlights: • Development and verification of a neutron diffusion solver based on OpenFOAM. • Integration in the GeN-Foam multi-physics platform. • Implementation and verification of acceleration techniques. • Implementation of isotropic discontinuity factors. • Automatic adjustment of discontinuity factors. - Abstract: The Laboratory for Reactor Physics and Systems Behaviour at the PSI and the EPFL has been developing in recent years a new code system for reactor analysis based on OpenFOAM®. The objective is to supplement available legacy codes with a modern tool featuring state-of-the-art characteristics in terms of scalability, programming approach and flexibility. As part of this project, a new solver has been developed for the eigenvalue and transient solution of multi-group diffusion equations. Several features distinguish the developed solver from other available codes, in particular: object oriented programming to ease code modification and maintenance; modern parallel computing capabilities; use of general unstructured meshes; possibility of mesh deformation; cell-wise parametrization of cross-sections; and arbitrary energy group structure. In addition, the solver is integrated into the GeN-Foam multi-physics solver. The general features of the solver and its integration with GeN-Foam have already been presented in previous publications. The present paper describes the diffusion solver in more details and provides an overview of new features recently implemented, including the use of acceleration techniques and discontinuity factors. In addition, a code verification is performed through a comparison with Monte Carlo results for both a thermal and a fast reactor system.

  4. KRYSI, Ordinary Differential Equations Solver with Sdirk Krylov Method

    International Nuclear Information System (INIS)

    Hindmarsh, A.C.; Norsett, S.P.

    2001-01-01

    1 - Description of program or function: KRYSI is a set of FORTRAN subroutines for solving ordinary differential equations initial value problems. It is suitable for both stiff and non-stiff systems. When solving the implicit stage equations in the stiff case, KRYSI uses a Krylov subspace iteration method called the SPIGMR (Scaled Preconditioned Incomplete Generalized Minimum Residual) method. No explicit Jacobian storage is required, except where used in pre- conditioning. A demonstration problem is included with a description of two pre-conditioners that are natural for its solution by KRYSI. 2 - Method of solution: KRYSI uses a three-stage, third-order singly diagonally implicit Runge-Kutta (SDIRK) method. In the stiff case, a preconditioned Krylov subspace iteration within a (so-called) inexact Newton iteration is used to solve the system of nonlinear algebraic equations

  5. A Study of Single- and Double-Averaged Second-Order Models to Evaluate Third-Body Perturbation Considering Elliptic Orbits for the Perturbing Body

    Directory of Open Access Journals (Sweden)

    R. C. Domingos

    2013-01-01

    Full Text Available The equations for the variations of the Keplerian elements of the orbit of a spacecraft perturbed by a third body are developed using a single average over the motion of the spacecraft, considering an elliptic orbit for the disturbing body. A comparison is made between this approach and the more used double averaged technique, as well as with the full elliptic restricted three-body problem. The disturbing function is expanded in Legendre polynomials up to the second order in both cases. The equations of motion are obtained from the planetary equations, and several numerical simulations are made to show the evolution of the orbit of the spacecraft. Some characteristics known from the circular perturbing body are studied: circular, elliptic equatorial, and frozen orbits. Different initial eccentricities for the perturbed body are considered, since the effect of this variable is one of the goals of the present study. The results show the impact of this parameter as well as the differences between both models compared to the full elliptic restricted three-body problem. Regions below, near, and above the critical angle of the third-body perturbation are considered, as well as different altitudes for the orbit of the spacecraft.

  6. Singularities of n-fold integrals of the Ising class and the theory of elliptic curves

    International Nuclear Information System (INIS)

    Boukraa, S; Hassani, S; Maillard, J-M; Zenine, N

    2007-01-01

    We introduce some multiple integrals that are expected to have the same singularities as the singularities of the n-particle contributions χ (n) to the susceptibility of the square lattice Ising model. We find the Fuchsian linear differential equation satisfied by these multiple integrals for n = 1, 2, 3, 4 and only modulo some primes for n = 5 and 6, thus providing a large set of (possible) new singularities of χ (n) . We discuss the singularity structure for these multiple integrals by solving the Landau conditions. We find that the singularities of the associated ODEs identify (up to n = 6) with the leading pinch Landau singularities. The second remarkable obtained feature is that the singularities of the ODEs associated with the multiple integrals reduce to the singularities of the ODEs associated with a finite number of one-dimensional integrals. Among the singularities found, we underline the fact that the quadratic polynomial condition 1 + 3w + 4w 2 = 0, that occurs in the linear differential equation of χ (3) , actually corresponds to a remarkable property of selected elliptic curves, namely the occurrence of complex multiplication. The interpretation of complex multiplication for elliptic curves as complex fixed points of the selected generators of the renormalization group, namely isogenies of elliptic curves, is sketched. Most of the other singularities occurring in our multiple integrals are not related to complex multiplication situations, suggesting an interpretation in terms of (motivic) mathematical structures beyond the theory of elliptic curves

  7. On the General Equation of the Second Degree

    Indian Academy of Sciences (India)

    IAS Admin

    On the General Equation of the Second Degree. Keywords. Conics, eigenvalues, eigenvec- tors, pairs of lines. S Kesavan. S Kesavan works at the. Institute for Mathematical. Sciences, Chennai. His area of interest is partial differential equations with specialization in elliptic problems connected to homogenization, control.

  8. Comparison of open-source linear programming solvers.

    Energy Technology Data Exchange (ETDEWEB)

    Gearhart, Jared Lee; Adair, Kristin Lynn; Durfee, Justin David.; Jones, Katherine A.; Martin, Nathaniel; Detry, Richard Joseph

    2013-10-01

    When developing linear programming models, issues such as budget limitations, customer requirements, or licensing may preclude the use of commercial linear programming solvers. In such cases, one option is to use an open-source linear programming solver. A survey of linear programming tools was conducted to identify potential open-source solvers. From this survey, four open-source solvers were tested using a collection of linear programming test problems and the results were compared to IBM ILOG CPLEX Optimizer (CPLEX) [1], an industry standard. The solvers considered were: COIN-OR Linear Programming (CLP) [2], [3], GNU Linear Programming Kit (GLPK) [4], lp_solve [5] and Modular In-core Nonlinear Optimization System (MINOS) [6]. As no open-source solver outperforms CPLEX, this study demonstrates the power of commercial linear programming software. CLP was found to be the top performing open-source solver considered in terms of capability and speed. GLPK also performed well but cannot match the speed of CLP or CPLEX. lp_solve and MINOS were considerably slower and encountered issues when solving several test problems.

  9. Design of a Modular Monolithic Implicit Solver for Multi-Physics Applications

    Science.gov (United States)

    Carton De Wiart, Corentin; Diosady, Laslo T.; Garai, Anirban; Burgess, Nicholas; Blonigan, Patrick; Ekelschot, Dirk; Murman, Scott M.

    2018-01-01

    The design of a modular multi-physics high-order space-time finite-element framework is presented together with its extension to allow monolithic coupling of different physics. One of the main objectives of the framework is to perform efficient high- fidelity simulations of capsule/parachute systems. This problem requires simulating multiple physics including, but not limited to, the compressible Navier-Stokes equations, the dynamics of a moving body with mesh deformations and adaptation, the linear shell equations, non-re effective boundary conditions and wall modeling. The solver is based on high-order space-time - finite element methods. Continuous, discontinuous and C1-discontinuous Galerkin methods are implemented, allowing one to discretize various physical models. Tangent and adjoint sensitivity analysis are also targeted in order to conduct gradient-based optimization, error estimation, mesh adaptation, and flow control, adding another layer of complexity to the framework. The decisions made to tackle these challenges are presented. The discussion focuses first on the "single-physics" solver and later on its extension to the monolithic coupling of different physics. The implementation of different physics modules, relevant to the capsule/parachute system, are also presented. Finally, examples of coupled computations are presented, paving the way to the simulation of the full capsule/parachute system.

  10. A high order solver for the unbounded Poisson equation

    DEFF Research Database (Denmark)

    Hejlesen, Mads Mølholm; Rasmussen, Johannes Tophøj; Chatelain, Philippe

    In mesh-free particle methods a high order solution to the unbounded Poisson equation is usually achieved by constructing regularised integration kernels for the Biot-Savart law. Here the singular, point particles are regularised using smoothed particles to obtain an accurate solution with an order...... of convergence consistent with the moments conserved by the applied smoothing function. In the hybrid particle-mesh method of Hockney and Eastwood (HE) the particles are interpolated onto a regular mesh where the unbounded Poisson equation is solved by a discrete non-cyclic convolution of the mesh values...... and the integration kernel. In this work we show an implementation of high order regularised integration kernels in the HE algorithm for the unbounded Poisson equation to formally achieve an arbitrary high order convergence. We further present a quantitative study of the convergence rate to give further insight...

  11. Abundant families of new traveling wave solutions for the coupled Drinfel'd-Sokolov-Wilson equation

    International Nuclear Information System (INIS)

    Yao Yuqin

    2005-01-01

    The generalized Jacobi elliptic function method is further improved by introducing an elliptic function φ(ξ) as a new independent variable and it is easy to calculate the over-determined equations. Abundant new traveling wave solutions of the coupled Drinfel'd-Sokolov-Wilson equation are obtained. The solutions obtained include the kink-shaped solutions, bell-shaped solutions, singular solutions and periodic solutions

  12. GeN-Foam: a novel OpenFOAM{sup ®} based multi-physics solver for 2D/3D transient analysis of nuclear reactors

    Energy Technology Data Exchange (ETDEWEB)

    Fiorina, Carlo, E-mail: carlo.fiorina@psi.ch [Paul Scherrer Institut, Nuclear Energy and Safety Department, Laboratory for Reactor Physics and Systems Behaviour – PSI, Villigen 5232 (Switzerland); Clifford, Ivor [Paul Scherrer Institut, Nuclear Energy and Safety Department, Laboratory for Reactor Physics and Systems Behaviour – PSI, Villigen 5232 (Switzerland); Aufiero, Manuele [LPSC-IN2P3-CNRS/UJF/Grenoble INP, 53 avenue des Martyrs, 38026 Grenoble Cedex (France); Mikityuk, Konstantin [Paul Scherrer Institut, Nuclear Energy and Safety Department, Laboratory for Reactor Physics and Systems Behaviour – PSI, Villigen 5232 (Switzerland)

    2015-12-01

    Highlights: • Development of a new multi-physics solver based on OpenFOAM{sup ®}. • Tight coupling of thermal-hydraulics, thermal-mechanics and neutronics. • Combined use of traditional RANS and porous-medium models. • Mesh for neutronics deformed according to the predicted displacement field. • Use of three unstructured meshes, adaptive time step, parallel computing. - Abstract: The FAST group at the Paul Scherrer Institut has been developing a code system for reactor analysis for many years. For transient analysis, this code system is currently based on a state-of-the-art coupled TRACE-PARCS routine. This work presents an attempt to supplement the FAST code system with a novel solver characterized by tight coupling between the different equations, parallel computing capabilities, adaptive time-stepping and more accurate treatment of some of the phenomena involved in a reactor transient. The new solver is based on OpenFOAM{sup ®}, an open-source C++ library for the solution of partial differential equations using finite-volume discretization. It couples together a multi-scale fine/coarse mesh sub-solver for thermal-hydraulics, a multi-group diffusion sub-solver for neutronics, a displacement-based sub-solver for thermal-mechanics and a finite-difference model for the temperature field in the fuel. It is targeted toward the analysis of pin-based reactors (e.g., liquid metal fast reactors or light water reactors) or homogeneous reactors (e.g., fast-spectrum molten salt reactors). This paper presents each “single-physics” sub-solver and the overall coupling strategy, using the sodium-cooled fast reactor as a test case, and essential code verification tests are described.

  13. Object-oriented philosophy in designing adaptive finite-element package for 3D elliptic deferential equations

    Science.gov (United States)

    Zhengyong, R.; Jingtian, T.; Changsheng, L.; Xiao, X.

    2007-12-01

    Although adaptive finite-element (AFE) analysis is becoming more and more focused in scientific and engineering fields, its efficient implementations are remain to be a discussed problem as its more complex procedures. In this paper, we propose a clear C++ framework implementation to show the powerful properties of Object-oriented philosophy (OOP) in designing such complex adaptive procedure. In terms of the modal functions of OOP language, the whole adaptive system is divided into several separate parts such as the mesh generation or refinement, a-posterior error estimator, adaptive strategy and the final post processing. After proper designs are locally performed on these separate modals, a connected framework of adaptive procedure is formed finally. Based on the general elliptic deferential equation, little efforts should be added in the adaptive framework to do practical simulations. To show the preferable properties of OOP adaptive designing, two numerical examples are tested. The first one is the 3D direct current resistivity problem in which the powerful framework is efficiently shown as only little divisions are added. And then, in the second induced polarization£¨IP£©exploration case, new adaptive procedure is easily added which adequately shows the strong extendibility and re-usage of OOP language. Finally we believe based on the modal framework adaptive implementation by OOP methodology, more advanced adaptive analysis system will be available in future.

  14. A generalized Poisson solver for first-principles device simulations

    Energy Technology Data Exchange (ETDEWEB)

    Bani-Hashemian, Mohammad Hossein; VandeVondele, Joost, E-mail: joost.vandevondele@mat.ethz.ch [Nanoscale Simulations, ETH Zürich, 8093 Zürich (Switzerland); Brück, Sascha; Luisier, Mathieu [Integrated Systems Laboratory, ETH Zürich, 8092 Zürich (Switzerland)

    2016-01-28

    Electronic structure calculations of atomistic systems based on density functional theory involve solving the Poisson equation. In this paper, we present a plane-wave based algorithm for solving the generalized Poisson equation subject to periodic or homogeneous Neumann conditions on the boundaries of the simulation cell and Dirichlet type conditions imposed at arbitrary subdomains. In this way, source, drain, and gate voltages can be imposed across atomistic models of electronic devices. Dirichlet conditions are enforced as constraints in a variational framework giving rise to a saddle point problem. The resulting system of equations is then solved using a stationary iterative method in which the generalized Poisson operator is preconditioned with the standard Laplace operator. The solver can make use of any sufficiently smooth function modelling the dielectric constant, including density dependent dielectric continuum models. For all the boundary conditions, consistent derivatives are available and molecular dynamics simulations can be performed. The convergence behaviour of the scheme is investigated and its capabilities are demonstrated.

  15. Preconditioning cubic spline collocation method by FEM and FDM for elliptic equations

    Energy Technology Data Exchange (ETDEWEB)

    Kim, Sang Dong [KyungPook National Univ., Taegu (Korea, Republic of)

    1996-12-31

    In this talk we discuss the finite element and finite difference technique for the cubic spline collocation method. For this purpose, we consider the uniformly elliptic operator A defined by Au := -{Delta}u + a{sub 1}u{sub x} + a{sub 2}u{sub y} + a{sub 0}u in {Omega} (the unit square) with Dirichlet or Neumann boundary conditions and its discretization based on Hermite cubic spline spaces and collocation at the Gauss points. Using an interpolatory basis with support on the Gauss points one obtains the matrix A{sub N} (h = 1/N).

  16. New exact solutions to the generalized KdV equation with ...

    Indian Academy of Sciences (India)

    is reduced to an ordinary differential equation with constant coefficients ... Application to generalized KdV equation with generalized evolution ..... [12] P F Byrd and M D Friedman, Handbook of elliptic integrals for engineers and physicists.

  17. Multiplicity of Solutions for a Class of Fourth-Order Elliptic Problems with Asymptotically Linear Term

    Directory of Open Access Journals (Sweden)

    Qiong Liu

    2012-01-01

    Full Text Available We study the following fourth-order elliptic equations: Δ2+Δ=(,,∈Ω,=Δ=0,∈Ω, where Ω⊂ℝ is a bounded domain with smooth boundary Ω and (, is asymptotically linear with respect to at infinity. Using an equivalent version of Cerami's condition and the symmetric mountain pass lemma, we obtain the existence of multiple solutions for the equations.

  18. Partial differential equations

    CERN Document Server

    Agranovich, M S

    2002-01-01

    Mark Vishik's Partial Differential Equations seminar held at Moscow State University was one of the world's leading seminars in PDEs for over 40 years. This book celebrates Vishik's eightieth birthday. It comprises new results and survey papers written by many renowned specialists who actively participated over the years in Vishik's seminars. Contributions include original developments and methods in PDEs and related fields, such as mathematical physics, tomography, and symplectic geometry. Papers discuss linear and nonlinear equations, particularly linear elliptic problems in angles and gener

  19. Acoustic scattering by multiple elliptical cylinders using collocation multipole method

    International Nuclear Information System (INIS)

    Lee, Wei-Ming

    2012-01-01

    This paper presents the collocation multipole method for the acoustic scattering induced by multiple elliptical cylinders subjected to an incident plane sound wave. To satisfy the Helmholtz equation in the elliptical coordinate system, the scattered acoustic field is formulated in terms of angular and radial Mathieu functions which also satisfy the radiation condition at infinity. The sound-soft or sound-hard boundary condition is satisfied by uniformly collocating points on the boundaries. For the sound-hard or Neumann conditions, the normal derivative of the acoustic pressure is determined by using the appropriate directional derivative without requiring the addition theorem of Mathieu functions. By truncating the multipole expansion, a finite linear algebraic system is derived and the scattered field can then be determined according to the given incident acoustic wave. Once the total field is calculated as the sum of the incident field and the scattered field, the near field acoustic pressure along the scatterers and the far field scattering pattern can be determined. For the acoustic scattering of one elliptical cylinder, the proposed results match well with the analytical solutions. The proposed scattered fields induced by two and three elliptical–cylindrical scatterers are critically compared with those provided by the boundary element method to validate the present method. Finally, the effects of the convexity of an elliptical scatterer, the separation between scatterers and the incident wave number and angle on the acoustic scattering are investigated.

  20. Applications of Operator-Splitting Methods to the Direct Numerical Simulation of Particulate and Free-Surface Flows and to the Numerical Solution of the Two-Dimensional Elliptic Monge--Ampère Equation

    OpenAIRE

    Glowinski, R.; Dean, E.J.; Guidoboni, G.; Juárez, L.H.; Pan, T.-W.

    2008-01-01

    The main goal of this article is to review some recent applications of operator-splitting methods. We will show that these methods are well-suited to the numerical solution of outstanding problems from various areas in Mechanics, Physics and Differential Geometry, such as the direct numerical simulation of particulate flow, free boundary problems with surface tension for incompressible viscous fluids, and the elliptic real Monge--Ampère equation. The results of numerical ...

  1. Derivations of the solid angle subtended at a point by first- and second-order surfaces and volumes as a function of elliptic integrals

    International Nuclear Information System (INIS)

    Cramer, S.N.

    1999-01-01

    An analytical study of the solid angle subtended at a point by objects of first and second algebraic order has been made. It is shown that the derived solid angle for all such objects is in the form of a general elliptic integral, which can be written as a linear combination of elliptic integrals of the first and third kind and elementary functions. Many common surfaces and volumes have been investigated, including the conic sections and their volumes of revolution. The principal feature of the study is the manipulation of solid-angle equations into integral forms that can be matched with those found in handbook tables. These integrals are amenable to computer special function library routine analysis requiring no direct interaction with elliptic integrals by the user. The general case requires the solution of a fourth-order equation before specific solid-angle formulations can be made, but for many common geometric objects this equation can be solved by elementary means. Methods for the testing and application of solid-angle equations with Monte Carlo rejection and estimation techniques are presented. Approximate and degenerate forms of the equations are shown, and methods for the evaluation of the solid angle of a torus are outlined

  2. Parallel Solver for Diffuse Optical Tomography on Realistic Head Models With Scattering and Clear Regions.

    Science.gov (United States)

    Placati, Silvio; Guermandi, Marco; Samore, Andrea; Scarselli, Eleonora Franchi; Guerrieri, Roberto

    2016-09-01

    Diffuse optical tomography is an imaging technique, based on evaluation of how light propagates within the human head to obtain the functional information about the brain. Precision in reconstructing such an optical properties map is highly affected by the accuracy of the light propagation model implemented, which needs to take into account the presence of clear and scattering tissues. We present a numerical solver based on the radiosity-diffusion model, integrating the anatomical information provided by a structural MRI. The solver is designed to run on parallel heterogeneous platforms based on multiple GPUs and CPUs. We demonstrate how the solver provides a 7 times speed-up over an isotropic-scattered parallel Monte Carlo engine based on a radiative transport equation for a domain composed of 2 million voxels, along with a significant improvement in accuracy. The speed-up greatly increases for larger domains, allowing us to compute the light distribution of a full human head ( ≈ 3 million voxels) in 116 s for the platform used.

  3. Travelling wave solutions to the Kuramoto-Sivashinsky equation

    International Nuclear Information System (INIS)

    Nickel, J.

    2007-01-01

    Combining the approaches given by Baldwin [Baldwin D et al. Symbolic computation of exact solutions expressible in hyperbolic and elliptic functions for nonlinear PDEs. J Symbol Comput 2004;37:669-705], Peng [Peng YZ. A polynomial expansion method and new general solitary wave solutions to KS equation. Comm Theor Phys 2003;39:641-2] and by Schuermann [Schuermann HW, Serov VS. Weierstrass' solutions to certain nonlinear wave and evolution equations. Proc progress electromagnetics research symposium, 28-31 March 2004, Pisa. p. 651-4; Schuermann HW. Traveling-wave solutions to the cubic-quintic nonlinear Schroedinger equation. Phys Rev E 1996;54:4312-20] leads to a method for finding exact travelling wave solutions of nonlinear wave and evolution equations (NLWEE). The first idea is to generalize ansaetze given by Baldwin and Peng to find elliptic solutions of NLWEEs. Secondly, conditions used by Schuermann to find physical (real and bounded) solutions and to discriminate between periodic and solitary wave solutions are used. The method is shown in detail by evaluating new solutions of the Kuramoto-Sivashinsky equation

  4. Transverse magnetic scattering by parallel conducting elliptic cylinders

    Science.gov (United States)

    Sebak, A.

    1991-10-01

    A boundary value solution to the problem of transverse magnetic multiple scattering by M parallel perfectly conducting elliptic cylinders is presented. The solution is an exact one and based on the separation-of-variables technique and the addition theorem for Mathieu functions. It is expressed in terms of a system of simultaneous linear equations of infinite order, which is then truncated for numerical computations. Representative numerical results for the scattered field by two cylinders are then generated, for some selected sizes and orientations parameters, and presented.

  5. The General Analytic Solution of a Functional Equation of Addition Type

    OpenAIRE

    Braden, H. W.; Buchstaber, V. M.

    1995-01-01

    The general analytic solution to the functional equation $$ \\phi_1(x+y)= { { \\biggl|\\matrix{\\phi_2(x)&\\phi_2(y)\\cr\\phi_3(x)&\\phi_3(y)\\cr}\\biggr|} \\over { \\biggl|\\matrix{\\phi_4(x)&\\phi_4(y)\\cr\\phi_5(x)&\\phi_5(y)\\cr}\\biggr|} } $$ is characterised. Up to the action of the symmetry group, this is described in terms of Weierstrass elliptic functions. We illustrate our theory by applying it to the classical addition theorems of the Jacobi elliptic functions and the functional equations $$ \\phi_1(x+...

  6. An inherently parallel method for solving discretized diffusion equations

    International Nuclear Information System (INIS)

    Eccleston, B.R.; Palmer, T.S.

    1999-01-01

    A Monte Carlo approach to solving linear systems of equations is being investigated in the context of the solution of discretized diffusion equations. While the technique was originally devised decades ago, changes in computer architectures (namely, massively parallel machines) have driven the authors to revisit this technique. There are a number of potential advantages to this approach: (1) Analog Monte Carlo techniques are inherently parallel; this is not necessarily true to today's more advanced linear equation solvers (multigrid, conjugate gradient, etc.); (2) Some forms of this technique are adaptive in that they allow the user to specify locations in the problem where resolution is of particular importance and to concentrate the work at those locations; and (3) These techniques permit the solution of very large systems of equations in that matrix elements need not be stored. The user could trade calculational speed for storage if elements of the matrix are calculated on the fly. The goal of this study is to compare the parallel performance of Monte Carlo linear solvers to that of a more traditional parallelized linear solver. The authors observe the linear speedup that they expect from the Monte Carlo algorithm, given that there is no domain decomposition to cause significant communication overhead. Overall, PETSc outperforms the Monte Carlo solver for the test problem. The PETSc parallel performance improves with larger numbers of unknowns for a given number of processors. Parallel performance of the Monte Carlo technique is independent of the size of the matrix and the number of processes. They are investigating modifications to the scheme to accommodate matrix problems with positive off-diagonal elements. They are also currently coding an on-the-fly version of the algorithm to investigate the solution of very large linear systems

  7. Introduction to COFFE: The Next-Generation HPCMP CREATE-AV CFD Solver

    Science.gov (United States)

    Glasby, Ryan S.; Erwin, J. Taylor; Stefanski, Douglas L.; Allmaras, Steven R.; Galbraith, Marshall C.; Anderson, W. Kyle; Nichols, Robert H.

    2016-01-01

    HPCMP CREATE-AV Conservative Field Finite Element (COFFE) is a modular, extensible, robust numerical solver for the Navier-Stokes equations that invokes modularity and extensibility from its first principles. COFFE implores a flexible, class-based hierarchy that provides a modular approach consisting of discretization, physics, parallelization, and linear algebra components. These components are developed with modern software engineering principles to ensure ease of uptake from a user's or developer's perspective. The Streamwise Upwind/Petrov-Galerkin (SU/PG) method is utilized to discretize the compressible Reynolds-Averaged Navier-Stokes (RANS) equations tightly coupled with a variety of turbulence models. The mathematics and the philosophy of the methodology that makes up COFFE are presented.

  8. Associative Yang-Baxter equation for quantum (semi-)dynamical R-matrices

    International Nuclear Information System (INIS)

    Sechin, Ivan; Zotov, Andrei

    2016-01-01

    In this paper we propose versions of the associative Yang-Baxter equation and higher order R-matrix identities which can be applied to quantum dynamical R-matrices. As is known quantum non-dynamical R-matrices of Baxter-Belavin type satisfy this equation. Together with unitarity condition and skew-symmetry it provides the quantum Yang-Baxter equation and a set of identities useful for different applications in integrable systems. The dynamical R-matrices satisfy the Gervais-Neveu-Felder (or dynamical Yang-Baxter) equation. Relation between the dynamical and non-dynamical cases is described by the IRF (interaction-round-a-face)-Vertex transformation. An alternative approach to quantum (semi-)dynamical R-matrices and related quantum algebras was suggested by Arutyunov, Chekhov, and Frolov (ACF) in their study of the quantum Ruijsenaars-Schneider model. The purpose of this paper is twofold. First, we prove that the ACF elliptic R-matrix satisfies the associative Yang-Baxter equation with shifted spectral parameters. Second, we directly prove a simple relation of the IRF-Vertex type between the Baxter-Belavin and the ACF elliptic R-matrices predicted previously by Avan and Rollet. It provides the higher order R-matrix identities and an explanation of the obtained equations through those for non-dynamical R-matrices. As a by-product we also get an interpretation of the intertwining transformation as matrix extension of scalar theta function likewise R-matrix is interpreted as matrix extension of the Kronecker function. Relations to the Gervais-Neveu-Felder equation and identities for the Felder’s elliptic R-matrix are also discussed.

  9. Numerical Methods for Partial Differential Equations

    CERN Document Server

    Guo, Ben-yu

    1987-01-01

    These Proceedings of the first Chinese Conference on Numerical Methods for Partial Differential Equations covers topics such as difference methods, finite element methods, spectral methods, splitting methods, parallel algorithm etc., their theoretical foundation and applications to engineering. Numerical methods both for boundary value problems of elliptic equations and for initial-boundary value problems of evolution equations, such as hyperbolic systems and parabolic equations, are involved. The 16 papers of this volume present recent or new unpublished results and provide a good overview of current research being done in this field in China.

  10. POISSON SUPERFISH, Poisson Equation Solver for Radio Frequency Cavity

    International Nuclear Information System (INIS)

    Colman, J.

    2001-01-01

    1 - Description of program or function: POISSON, SUPERFISH is a group of (1) codes that solve Poisson's equation and are used to compute field quality for both magnets and fixed electric potentials and (2) RF cavity codes that calculate resonant frequencies and field distributions of the fundamental and higher modes. The group includes: POISSON, PANDIRA, SUPERFISH, AUTOMESH, LATTICE, FORCE, MIRT, PAN-T, TEKPLOT, SF01, and SHY. POISSON solves Poisson's (or Laplace's) equation for the vector (scalar) potential with nonlinear isotropic iron (dielectric) and electric current (charge) distributions for two-dimensional Cartesian or three-dimensional cylindrical symmetry. It calculates the derivatives of the potential, the stored energy, and performs harmonic (multipole) analysis of the potential. PANDIRA is similar to POISSON except it allows anisotropic and permanent magnet materials and uses a different numerical method to obtain the potential. SUPERFISH solves for the accelerating (TM) and deflecting (TE) resonant frequencies and field distributions in an RF cavity with two-dimensional Cartesian or three-dimensional cylindrical symmetry. Only the azimuthally symmetric modes are found for cylindrically symmetric cavities. AUTOMESH prepares input for LATTICE from geometrical data describing the problem, (i.e., it constructs the 'logical' mesh and generates (x,y) coordinate data for straight lines, arcs of circles, and segments of hyperbolas). LATTICE generates an irregular triangular (physical) mesh from the input data, calculates the 'point current' terms at each mesh point in regions with distributed current density, and sets up the mesh point relaxation order needed to write the binary problem file for the equation-solving POISSON, PANDIRA, or SUPERFISH. FORCE calculates forces and torques on coils and iron regions from POISSON or PANDIRA solutions for the potential. MIRT optimizes magnet profiles, coil shapes, and current densities from POISSON output based on a

  11. Numerical solutions of diffusive logistic equation

    International Nuclear Information System (INIS)

    Afrouzi, G.A.; Khademloo, S.

    2007-01-01

    In this paper we investigate numerically positive solutions of a superlinear Elliptic equation on bounded domains. The study of Diffusive logistic equation continues to be an active field of research. The subject has important applications to population migration as well as many other branches of science and engineering. In this paper the 'finite difference scheme' will be developed and compared for solving the one- and three-dimensional Diffusive logistic equation. The basis of the analysis of the finite difference equations considered here is the modified equivalent partial differential equation approach, developed from many authors these years

  12. Interrogation of orbital structure by elliptically polarized intense femtosecond laser pulses

    International Nuclear Information System (INIS)

    Abu-samha, M.; Madsen, L. B.

    2011-01-01

    We solve the three-dimensional time-dependent Schroedinger equation and present investigations of the imprint of the orbital angular node in photoelectron momentum distributions of an aligned atomic p-type orbital following ionization by an intense elliptically polarized laser pulse of femtosecond duration. We investigate the role of light ellipticity and the alignment angle of the major polarization axis of the external field relative to the probed orbital by studying radial and angular momentum distributions, the latter at a fixed narrow interval of final momenta close to the peak of the photoelectron momentum distribution. In general only the angular distributions carry a clear signature of the orbital symmetry. Our study shows that circular polarization gives the most clear imprints of orbital nodes. These findings are insensitive to pulse duration.

  13. An h-adaptive finite element solver for the calculations of the electronic structures

    International Nuclear Information System (INIS)

    Bao Gang; Hu Guanghui; Liu Di

    2012-01-01

    In this paper, a framework of using h-adaptive finite element method for the Kohn–Sham equation on the tetrahedron mesh is presented. The Kohn–Sham equation is discretized by the finite element method, and the h-adaptive technique is adopted to optimize the accuracy and the efficiency of the algorithm. The locally optimal block preconditioned conjugate gradient method is employed for solving the generalized eigenvalue problem, and an algebraic multigrid preconditioner is used to accelerate the solver. A variety of numerical experiments demonstrate the effectiveness of our algorithm for both the all-electron and the pseudo-potential calculations.

  14. Iterative solutions of finite difference diffusion equations

    International Nuclear Information System (INIS)

    Menon, S.V.G.; Khandekar, D.C.; Trasi, M.S.

    1981-01-01

    The heterogeneous arrangement of materials and the three-dimensional character of the reactor physics problems encountered in the design and operation of nuclear reactors makes it necessary to use numerical methods for solution of the neutron diffusion equations which are based on the linear Boltzmann equation. The commonly used numerical method for this purpose is the finite difference method. It converts the diffusion equations to a system of algebraic equations. In practice, the size of this resulting algebraic system is so large that the iterative methods have to be used. Most frequently used iterative methods are discussed. They include : (1) basic iterative methods for one-group problems, (2) iterative methods for eigenvalue problems, and (3) iterative methods which use variable acceleration parameters. Application of Chebyshev theorem to iterative methods is discussed. The extension of the above iterative methods to multigroup neutron diffusion equations is also considered. These methods are applicable to elliptic boundary value problems in reactor design studies in particular, and to elliptic partial differential equations in general. Solution of sample problems is included to illustrate their applications. The subject matter is presented in as simple a manner as possible. However, a working knowledge of matrix theory is presupposed. (M.G.B.)

  15. Structure of stable degeneration of K3 surfaces into pairs of rational elliptic surfaces

    Science.gov (United States)

    Kimura, Yusuke

    2018-03-01

    F-theory/heterotic duality is formulated in the stable degeneration limit of a K3 fibration on the F-theory side. In this note, we analyze the structure of the stable degeneration limit. We discuss whether stable degeneration exists for pairs of rational elliptic surfaces. We demonstrate that, when two rational elliptic surfaces have an identical complex structure, stable degeneration always exists. We provide an equation that systematically describes the stable degeneration of a K3 surface into a pair of isomorphic rational elliptic surfaces. When two rational elliptic surfaces have different complex structures, whether their sum glued along a smooth fiber admits deformation to a K3 surface can be determined by studying the structure of the K3 lattice. We investigate the lattice theoretic condition to determine whether a deformation to a K3 surface exists for pairs of extremal rational elliptic surfaces. In addition, we discuss the configurations of singular fibers under stable degeneration. The sum of two isomorphic rational elliptic surfaces glued together admits a deformation to a K3 surface, the singular fibers of which are twice that of the rational elliptic surface. For special situations, singular fibers of the resulting K3 surface collide and they are enhanced to a fiber of another type. Some K3 surfaces become attractive in these situations. We determine the complex structures and the Weierstrass forms of these attractive K3 surfaces. We also deduce the gauge groups in F-theory compactifications on these attractive K3 surfaces times a K3. E 6, E 7, E 8, SU(5), and SO(10) gauge groups arise in these compactifications.

  16. Transient analysis of plasmonic nanostructures using an MOT-PMCHWT solver

    KAUST Repository

    Uysal, Ismail Enes

    2015-10-26

    A marching on in time (MOT) scheme for solving the Poggio-Miller-Chan-Harrington-Wu-Tsai (PMCHWT) surface integral equation on plasmonic nanostructures is described. The proposed scheme calls for temporal convolutions of the permittivity and Green function of the plasmonic medium with the temporal basis function. Time domain samples of the permittivity and the Green function required by these convolutions are computed using a fast relaxed vector fitting (FRVF) algorithm. Numerical results demonstrate the accuracy and applicability of the proposed MOT-PMCHWT solver.

  17. Vanishing viscosity limits of mixed hyperbolic–elliptic systems arising in multilayer channel flows

    International Nuclear Information System (INIS)

    Papaefthymiou, E S; Papageorgiou, D T

    2015-01-01

    This study considers the spatially periodic initial value problem of 2 × 2 quasi-linear parabolic systems in one space dimension having quadratic polynomial flux functions. These systems arise physically in the interfacial dynamics of viscous immiscible multilayer channel flows. The equations describe the spatiotemporal evolution of phase-separating interfaces with dissipation arising from surface tension (fourth-order) and/or stable stratification effects (second-order). A crucial mathematical aspect of these systems is the presence of mixed hyperbolic–elliptic flux functions that provide the only source of instability. The study concentrates on scaled spatially 2π-periodic solutions as the dissipation vanishes, and in particular the behaviour of such limits when generalized dissipation operators (spanning second to fourth-order) are considered. Extensive numerical computations and asymptotic analysis suggest that the existence (or not) of bounded vanishing viscosity solutions depends crucially on the structure of the flux function. In the absence of linear terms (i.e. homogeneous flux functions) the vanishing viscosity limit does not exist in the L ∞ -norm. On the other hand, if linear terms in the flux function are present the computations strongly suggest that the solutions exist and are bounded in the L ∞ -norm as the dissipation vanishes. It is found that the key mechanism that provides such boundedness centres on persistent spatiotemporal hyperbolic–elliptic transitions. Strikingly, as the dissipation decreases, the flux function becomes almost everywhere hyperbolic except on a fractal set of elliptic regions, whose dimension depends on the order of the regularized operator. Furthermore, the spatial structures of the emerging weak solutions are found to support an increasing number of discontinuities (measure-valued solutions) located in the vicinity of the fractally distributed elliptic regions. For the unscaled problem, such spatially

  18. Numerical Analysis of Partial Differential Equations

    CERN Document Server

    Lions, Jacques-Louis

    2011-01-01

    S. Albertoni: Alcuni metodi di calcolo nella teoria della diffusione dei neutroni.- I. Babuska: Optimization and numerical stability in computations.- J.H. Bramble: Error estimates in elliptic boundary value problems.- G. Capriz: The numerical approach to hydrodynamic problems.- A. Dou: Energy inequalities in an elastic cylinder.- T. Doupont: On the existence of an iterative method for the solution of elliptic difference equation with an improved work estimate.- J. Douglas, J.R. Cannon: The approximation of harmonic and parabolic functions of half-spaces from interior data.- B.E. Hubbard: Erro

  19. Convergence acceleration of Navier-Stokes equation using adaptive wavelet method

    International Nuclear Information System (INIS)

    Kang, Hyung Min; Ghafoor, Imran; Lee, Do Hyung

    2010-01-01

    An efficient adaptive wavelet method is proposed for the enhancement of computational efficiency of the Navier-Stokes equations. The method is based on sparse point representation (SPR), which uses the wavelet decomposition and thresholding to obtain a sparsely distributed dataset. The threshold mechanism is modified in order to maintain the spatial accuracy of a conventional Navier-Stokes solver by adapting the threshold value to the order of spatial truncation error. The computational grid can be dynamically adapted to a transient solution to reflect local changes in the solution. The flux evaluation is then carried out only at the points of the adapted dataset, which reduces the computational effort and memory requirements. A stabilization technique is also implemented to avoid the additional numerical errors introduced by the threshold procedure. The numerical results of the adaptive wavelet method are compared with a conventional solver to validate the enhancement in computational efficiency of Navier-Stokes equations without the degeneration of the numerical accuracy of a conventional solver

  20. Elliptic-symmetry vector optical fields.

    Science.gov (United States)

    Pan, Yue; Li, Yongnan; Li, Si-Min; Ren, Zhi-Cheng; Kong, Ling-Jun; Tu, Chenghou; Wang, Hui-Tian

    2014-08-11

    We present in principle and demonstrate experimentally a new kind of vector fields: elliptic-symmetry vector optical fields. This is a significant development in vector fields, as this breaks the cylindrical symmetry and enriches the family of vector fields. Due to the presence of an additional degrees of freedom, which is the interval between the foci in the elliptic coordinate system, the elliptic-symmetry vector fields are more flexible than the cylindrical vector fields for controlling the spatial structure of polarization and for engineering the focusing fields. The elliptic-symmetry vector fields can find many specific applications from optical trapping to optical machining and so on.

  1. Ellipticity dependence of the near-threshold harmonics of H2 in an elliptical strong laser field.

    Science.gov (United States)

    Yang, Hua; Liu, Peng; Li, Ruxin; Xu, Zhizhan

    2013-11-18

    We study the ellipticity dependence of the near-threshold (NT) harmonics of pre-aligned H2 molecules using the time-dependent density functional theory. The anomalous maximum appearing at a non-zero ellipticity for the generated NT harmonics can be attributed to multiphoton effects of the orthogonally polarized component of the elliptical driving laser field. Our calculation also shows that the structure of the bound-state, such as molecular alignment and bond length, can be sensitively reflected on the ellipticity dependence of the near-threshold harmonics.

  2. Partial differential equations with numerical methods

    CERN Document Server

    Larsson, Stig

    2003-01-01

    The book is suitable for advanced undergraduate and beginning graduate students of applied mathematics and engineering. The main theme is the integration of the theory of linear PDEs and the numerical solution of such equations. For each type of PDE, elliptic, parabolic, and hyperbolic, the text contains one chapter on the mathematical theory of the differential equation, followed by one chapter on finite difference methods and one on finite element methods. As preparation, the two-point boundary value problem and the initial-value problem for ODEs are discussed in separate chapters. There is also one chapter on the elliptic eigenvalue problem and eigenfunction expansion. The presentation does not presume a deep knowledge of mathematical and functional analysis. Some background on linear functional analysis and Sobolev spaces, and also on numerical linear algebra, is reviewed in two appendices.

  3. Partial differential equations of parabolic type

    CERN Document Server

    Friedman, Avner

    2008-01-01

    This accessible and self-contained treatment provides even readers previously unacquainted with parabolic and elliptic equations with sufficient background to understand research literature. Author Avner Friedman - Director of the Mathematical Biosciences Institute at The Ohio State University - offers a systematic and thorough approach that begins with the main facts of the general theory of second order linear parabolic equations. Subsequent chapters explore asymptotic behavior of solutions, semi-linear equations and free boundary problems, and the extension of results concerning fundamenta

  4. Two-loop integrals for CP-even heavy quarkonium production and decays: elliptic sectors

    Science.gov (United States)

    Chen, Long-Bin; Jiang, Jun; Qiao, Cong-Feng

    2018-04-01

    By employing the differential equations, we compute analytically the elliptic sectors of two-loop master integrals appearing in the NNLO QCD corrections to CP-even heavy quarkonium exclusive production and decays, which turns out to be the last and toughest part in the relevant calculation. The integrals are found can be expressed as Goncharov polylogarithms and iterative integrals over elliptic functions. The master integrals may be applied to some other NNLO QCD calculations about heavy quarkonium exclusive production, like {γ}^{\\ast}γ \\to Q\\overline{Q} , {e}+{e}-\\to γ +Q\\overline{Q} , and H/{Z}^0\\to γ +Q\\overline{Q} , heavy quarkonium exclusive decays, and also the CP-even heavy quarkonium inclusive production and decays.

  5. On the asymptotic of solutions of elliptic boundary value problems in domains with edges

    International Nuclear Information System (INIS)

    Nkemzi, B.

    2005-10-01

    Solutions of elliptic boundary value problems in three-dimensional domains with edges may exhibit singularities. The usual procedure to study these singularities is by the application of the classical Mellin transformation or continuous Fourier transformation. In this paper, we show how the asymptotic behavior of solutions of elliptic boundary value problems in general three-dimensional domains with straight edges can be investigated by means of discrete Fourier transformation. We apply this approach to time-harmonic Maxwell's equations and prove that the singular solutions can fully be described in terms of Fourier series. The representation here can easily be used to approximate three-dimensional stress intensity factors associated with edge singularities. (author)

  6. Exact solutions for the cubic-quintic nonlinear Schroedinger equation

    International Nuclear Information System (INIS)

    Zhu Jiamin; Ma Zhengyi

    2007-01-01

    In this paper, the cubic-quintic nonlinear Schroedinger equation is solved through the extended elliptic sub-equation method. As a consequence, many types of exact travelling wave solutions are obtained which including bell and kink profile solitary wave solutions, triangular periodic wave solutions and singular solutions

  7. Scalable implicit methods for reaction-diffusion equations in two and three space dimensions

    Energy Technology Data Exchange (ETDEWEB)

    Veronese, S.V.; Othmer, H.G. [Univ. of Utah, Salt Lake City, UT (United States)

    1996-12-31

    This paper describes the implementation of a solver for systems of semi-linear parabolic partial differential equations in two and three space dimensions. The solver is based on a parallel implementation of a non-linear Alternating Direction Implicit (ADI) scheme which uses a Cartesian grid in space and an implicit time-stepping algorithm. Various reordering strategies for the linearized equations are used to reduce the stride and improve the overall effectiveness of the parallel implementation. We have successfully used this solver for large-scale reaction-diffusion problems in computational biology and medicine in which the desired solution is a traveling wave that may contain rapid transitions. A number of examples that illustrate the efficiency and accuracy of the method are given here; the theoretical analysis will be presented.

  8. Elliptic Flow, Initial Eccentricity and Elliptic Flow Fluctuations in Heavy Ion Collisions at RHIC

    Science.gov (United States)

    Nouicer, Rachid; Alver, B.; Back, B. B.; Baker, M. D.; Ballintijn, M.; Barton, D. S.; Betts, R. R.; Bickley, A. A.; Bindel, R.; Busza, W.; Carroll, A.; Chai, Z.; Decowski, M. P.; García, E.; Gburek, T.; George, N.; Gulbrandsen, K.; Halliwell, C.; Hamblen, J.; Hauer, M.; Henderson, C.; Hofman, D. J.; Hollis, R. S.; Holzman, B.; Iordanova, A.; Kane, J. L.; Khan, N.; Kulinich, P.; Kuo, C. M.; Li, W.; Lin, W. T.; Loizides, C.; Manly, S.; Mignerey, A. C.; Nouicer, R.; Olszewski, A.; Pak, R.; Reed, C.; Roland, C.; Roland, G.; Sagerer, J.; Seals, H.; Sedykh, I.; Smith, C. E.; Stankiewicz, M. A.; Steinberg, P.; Stephans, G. S. F.; Sukhanov, A.; Tonjes, M. B.; Trzupek, A.; Vale, C.; van Nieuwenhuizen, G. J.; Vaurynovich, S. S.; Verdier, R.; Veres, G. I.; Walters, P.; Wenger, E.; Wolfs, F. L. H.; Wosiek, B.; Woźniak, K.; Wysłouch, B.

    2008-12-01

    We present measurements of elliptic flow and event-by-event fluctuations established by the PHOBOS experiment. Elliptic flow scaled by participant eccentricity is found to be similar for both systems when collisions with the same number of participants or the same particle area density are compared. The agreement of elliptic flow between Au+Au and Cu+Cu collisions provides evidence that the matter is created in the initial stage of relativistic heavy ion collisions with transverse granularity similar to that of the participant nucleons. The event-by-event fluctuation results reveal that the initial collision geometry is translated into the final state azimuthal particle distribution, leading to an event-by-event proportionality between the observed elliptic flow and initial eccentricity.

  9. Discontinuous Galerkin methods for plasma physics in the scrape-off layer of tokamaks

    International Nuclear Information System (INIS)

    Michoski, C.; Meyerson, D.; Isaac, T.; Waelbroeck, F.

    2014-01-01

    A new parallel discontinuous Galerkin solver, called ArcOn, is developed to describe the intermittent turbulent transport of filamentary blobs in the scrape-off layer (SOL) of fusion plasma. The model is comprised of an elliptic subsystem coupled to two convection-dominated reaction–diffusion–convection equations. Upwinding is used for a class of numerical fluxes developed to accommodate cross product driven convection, and the elliptic solver uses SIPG, NIPG, IIPG, Brezzi, and Bassi–Rebay fluxes to formulate the stiffness matrix. A novel entropy sensor is developed for this system, designed for a space–time varying artificial diffusion/viscosity regularization algorithm. Some numerical experiments are performed to show convergence order on manufactured solutions, regularization of blob/streamer dynamics in the SOL given unstable parameterizations, long-time stability of modon (or dipole drift vortex) solutions arising in simulations of drift-wave turbulence, and finally the formation of edge mode turbulence in the scrape-off layer under turbulent saturation conditions

  10. The exact solution to the one-dimensional Poisson–Boltzmann equation with asymmetric boundary conditions

    DEFF Research Database (Denmark)

    Johannessen, Kim

    2014-01-01

    The exact solution to the one-dimensional Poisson–Boltzmann equation with asymmetric boundary conditions can be expressed in terms of the Jacobi elliptic functions. The boundary conditions determine the modulus of the Jacobi elliptic functions. The boundary conditions can not be solved analytically...

  11. Discrete conservation of nonnegativity for elliptic problems solved by the hp-FEM

    Czech Academy of Sciences Publication Activity Database

    Šolín, P.; Vejchodský, Tomáš; Araiza, R.

    2007-01-01

    Roč. 76, 1-3 (2007), s. 205-210 ISSN 0378-4754 R&D Projects: GA ČR GP201/04/P021 Institutional research plan: CEZ:AV0Z10190503 Keywords : discrete nonnegativity conservation * discrete Green's function * elliptic problems * hp-FEM * higher-order finite element methods * Poisson equation * numerical experimetns Subject RIV: BA - General Mathematics Impact factor: 0.738, year: 2007

  12. The spectral element approach for the solution of neutron transport problems

    International Nuclear Information System (INIS)

    Barbarino, A.; Dulla, S.; Ravetto, P.; Mund, E.H.

    2011-01-01

    In this paper a possible application of the Spectral Element Method to neutron transport problems is presented. The basic features of the numerical scheme on the one-dimensional diffusion equation are illustrated. Then, the AN model for neutron transport is introduced, and the basic steps for the construction of a bi-dimensional solver are described. The AN equations are chosen for their structure, involving a system of coupled elliptic-type equations. Some calculations are carried out on typical benchmark problems and results are compared with the Finite Element Method, in order to evaluate their performances. (author)

  13. A Comparison of Monte Carlo and Deterministic Solvers for keff and Sensitivity Calculations

    Energy Technology Data Exchange (ETDEWEB)

    Haeck, Wim [Los Alamos National Lab. (LANL), Los Alamos, NM (United States); Parsons, Donald Kent [Los Alamos National Lab. (LANL), Los Alamos, NM (United States); White, Morgan Curtis [Los Alamos National Lab. (LANL), Los Alamos, NM (United States); Saller, Thomas [Los Alamos National Lab. (LANL), Los Alamos, NM (United States); Favorite, Jeffrey A. [Los Alamos National Lab. (LANL), Los Alamos, NM (United States)

    2017-12-12

    Verification and validation of our solutions for calculating the neutron reactivity for nuclear materials is a key issue to address for many applications, including criticality safety, research reactors, power reactors, and nuclear security. Neutronics codes solve variations of the Boltzmann transport equation. The two main variants are Monte Carlo versus deterministic solutions, e.g. the MCNP [1] versus PARTISN [2] codes, respectively. There have been many studies over the decades that examined the accuracy of such solvers and the general conclusion is that when the problems are well-posed, either solver can produce accurate results. However, the devil is always in the details. The current study examines the issue of self-shielding and the stress it puts on deterministic solvers. Most Monte Carlo neutronics codes use continuous-energy descriptions of the neutron interaction data that are not subject to this effect. The issue of self-shielding occurs because of the discretisation of data used by the deterministic solutions. Multigroup data used in these solvers are the average cross section and scattering parameters over an energy range. Resonances in cross sections can occur that change the likelihood of interaction by one to three orders of magnitude over a small energy range. Self-shielding is the numerical effect that the average cross section in groups with strong resonances can be strongly affected as neutrons within that material are preferentially absorbed or scattered out of the resonance energies. This affects both the average cross section and the scattering matrix.

  14. A Numerical Study of Scalable Cardiac Electro-Mechanical Solvers on HPC Architectures

    Directory of Open Access Journals (Sweden)

    Piero Colli Franzone

    2018-04-01

    Full Text Available We introduce and study some scalable domain decomposition preconditioners for cardiac electro-mechanical 3D simulations on parallel HPC (High Performance Computing architectures. The electro-mechanical model of the cardiac tissue is composed of four coupled sub-models: (1 the static finite elasticity equations for the transversely isotropic deformation of the cardiac tissue; (2 the active tension model describing the dynamics of the intracellular calcium, cross-bridge binding and myofilament tension; (3 the anisotropic Bidomain model describing the evolution of the intra- and extra-cellular potentials in the deforming cardiac tissue; and (4 the ionic membrane model describing the dynamics of ionic currents, gating variables, ionic concentrations and stretch-activated channels. This strongly coupled electro-mechanical model is discretized in time with a splitting semi-implicit technique and in space with isoparametric finite elements. The resulting scalable parallel solver is based on Multilevel Additive Schwarz preconditioners for the solution of the Bidomain system and on BDDC preconditioned Newton-Krylov solvers for the non-linear finite elasticity system. The results of several 3D parallel simulations show the scalability of both linear and non-linear solvers and their application to the study of both physiological excitation-contraction cardiac dynamics and re-entrant waves in the presence of different mechano-electrical feedbacks.

  15. Transforming parts of a differential equations system to difference equations as a method for run-time savings in NONMEM.

    Science.gov (United States)

    Petersson, K J F; Friberg, L E; Karlsson, M O

    2010-10-01

    Computer models of biological systems grow more complex as computing power increase. Often these models are defined as differential equations and no analytical solutions exist. Numerical integration is used to approximate the solution; this can be computationally intensive, time consuming and be a large proportion of the total computer runtime. The performance of different integration methods depend on the mathematical properties of the differential equations system at hand. In this paper we investigate the possibility of runtime gains by calculating parts of or the whole differential equations system at given time intervals, outside of the differential equations solver. This approach was tested on nine models defined as differential equations with the goal to reduce runtime while maintaining model fit, based on the objective function value. The software used was NONMEM. In four models the computational runtime was successfully reduced (by 59-96%). The differences in parameter estimates, compared to using only the differential equations solver were less than 12% for all fixed effects parameters. For the variance parameters, estimates were within 10% for the majority of the parameters. Population and individual predictions were similar and the differences in OFV were between 1 and -14 units. When computational runtime seriously affects the usefulness of a model we suggest evaluating this approach for repetitive elements of model building and evaluation such as covariate inclusions or bootstraps.

  16. Elliptical concentrators.

    Science.gov (United States)

    Garcia-Botella, Angel; Fernandez-Balbuena, Antonio Alvarez; Bernabeu, Eusebio

    2006-10-10

    Nonimaging optics is a field devoted to the design of optical components for applications such as solar concentration or illumination. In this field, many different techniques have been used to produce optical devices, including the use of reflective and refractive components or inverse engineering techniques. However, many of these optical components are based on translational symmetries, rotational symmetries, or free-form surfaces. We study a new family of nonimaging concentrators called elliptical concentrators. This new family of concentrators provides new capabilities and can have different configurations, either homofocal or nonhomofocal. Translational and rotational concentrators can be considered as particular cases of elliptical concentrators.

  17. Summer Proceedings 2016: The Center for Computing Research at Sandia National Laboratories

    Energy Technology Data Exchange (ETDEWEB)

    Carleton, James Brian [Sandia National Lab. (SNL-NM), Albuquerque, NM (United States); Parks, Michael L. [Sandia National Lab. (SNL-NM), Albuquerque, NM (United States)

    2017-02-01

    Solving sparse linear systems from the discretization of elliptic partial differential equations (PDEs) is an important building block in many engineering applications. Sparse direct solvers can solve general linear systems, but are usually slower and use much more memory than effective iterative solvers. To overcome these two disadvantages, a hierarchical solver (LoRaSp) based on H2-matrices was introduced in [22]. Here, we have developed a parallel version of the algorithm in LoRaSp to solve large sparse matrices on distributed memory machines. On a single processor, the factorization time of our parallel solver scales almost linearly with the problem size for three-dimensional problems, as opposed to the quadratic scalability of many existing sparse direct solvers. Moreover, our solver leads to almost constant numbers of iterations, when used as a preconditioner for Poisson problems. On more than one processor, our algorithm has significant speedups compared to sequential runs. With this parallel algorithm, we are able to solve large problems much faster than many existing packages as demonstrated by the numerical experiments.

  18. Nonlinear multigrid solvers exploiting AMGe coarse spaces with approximation properties

    DEFF Research Database (Denmark)

    Christensen, Max la Cour; Vassilevski, Panayot S.; Villa, Umberto

    2017-01-01

    discretizations on general unstructured grids for a large class of nonlinear partial differential equations, including saddle point problems. The approximation properties of the coarse spaces ensure that our FAS approach for general unstructured meshes leads to optimal mesh-independent convergence rates similar...... to those achieved by geometric FAS on a nested hierarchy of refined meshes. In the numerical results, Newton’s method and Picard iterations with state-of-the-art inner linear solvers are compared to our FAS algorithm for the solution of a nonlinear saddle point problem arising from porous media flow...

  19. Algorithms for parallel flow solvers on message passing architectures

    Science.gov (United States)

    Vanderwijngaart, Rob F.

    1995-01-01

    The purpose of this project has been to identify and test suitable technologies for implementation of fluid flow solvers -- possibly coupled with structures and heat equation solvers -- on MIMD parallel computers. In the course of this investigation much attention has been paid to efficient domain decomposition strategies for ADI-type algorithms. Multi-partitioning derives its efficiency from the assignment of several blocks of grid points to each processor in the parallel computer. A coarse-grain parallelism is obtained, and a near-perfect load balance results. In uni-partitioning every processor receives responsibility for exactly one block of grid points instead of several. This necessitates fine-grain pipelined program execution in order to obtain a reasonable load balance. Although fine-grain parallelism is less desirable on many systems, especially high-latency networks of workstations, uni-partition methods are still in wide use in production codes for flow problems. Consequently, it remains important to achieve good efficiency with this technique that has essentially been superseded by multi-partitioning for parallel ADI-type algorithms. Another reason for the concentration on improving the performance of pipeline methods is their applicability in other types of flow solver kernels with stronger implied data dependence. Analytical expressions can be derived for the size of the dynamic load imbalance incurred in traditional pipelines. From these it can be determined what is the optimal first-processor retardation that leads to the shortest total completion time for the pipeline process. Theoretical predictions of pipeline performance with and without optimization match experimental observations on the iPSC/860 very well. Analysis of pipeline performance also highlights the effect of uncareful grid partitioning in flow solvers that employ pipeline algorithms. If grid blocks at boundaries are not at least as large in the wall-normal direction as those

  20. Open problems in CEM: Porting an explicit time-domain volume-integral- equation solver on GPUs with OpenACC

    KAUST Repository

    Ergü l, Ö zgü r; Feki, Saber; Al-Jarro, Ahmed; Clo, Alain M.; Bagci, Hakan

    2014-01-01

    -level approach, utilizing the OpenACC directive-based parallel programming model, is used to minimize two often-faced challenges in GPU programming: developer productivity and code portability. The MOT-TDVIE solver code, originally developed for CPUs

  1. Some Further Results on Traveling Wave Solutions for the ZK-BBM( Equations

    Directory of Open Access Journals (Sweden)

    Shaoyong Li

    2013-01-01

    Full Text Available We investigate the traveling wave solutions for the ZK-BBM( equations by using bifurcation method of dynamical systems. Firstly, for ZK-BBM(2, 2 equation, we obtain peakon wave, periodic peakon wave, and smooth periodic wave solutions and point out that the peakon wave is the limit form of the periodic peakon wave. Secondly, for ZK-BBM(3, 2 equation, we obtain some elliptic function solutions which include periodic blow-up and periodic wave. Furthermore, from the limit forms of the elliptic function solutions, we obtain some trigonometric and hyperbolic function solutions which include periodic blow-up, blow-up, and smooth solitary wave. We also show that our work extends some previous results.

  2. Extended Jacobi Elliptic Function Rational Expansion Method and Its Application to (2+1)-Dimensional Stochastic Dispersive Long Wave System

    International Nuclear Information System (INIS)

    Song Lina; Zhang Hongqing

    2007-01-01

    In this work, by means of a generalized method and symbolic computation, we extend the Jacobi elliptic function rational expansion method to uniformly construct a series of stochastic wave solutions for stochastic evolution equations. To illustrate the effectiveness of our method, we take the (2+1)-dimensional stochastic dispersive long wave system as an example. We not only have obtained some known solutions, but also have constructed some new rational formal stochastic Jacobi elliptic function solutions.

  3. Methods to Load Balance a GCR Pressure Solver Using a Stencil Framework on Multi- and Many-Core Architectures

    Directory of Open Access Journals (Sweden)

    Milosz Ciznicki

    2015-01-01

    Full Text Available The recent advent of novel multi- and many-core architectures forces application programmers to deal with hardware-specific implementation details and to be familiar with software optimisation techniques to benefit from new high-performance computing machines. Extra care must be taken for communication-intensive algorithms, which may be a bottleneck for forthcoming era of exascale computing. This paper aims to present a high-level stencil framework implemented for the EULerian or LAGrangian model (EULAG that efficiently utilises multi- and many-cores architectures. Only an efficient usage of both many-core processors (CPUs and graphics processing units (GPUs with the flexible data decomposition method can lead to the maximum performance that scales the communication-intensive Generalized Conjugate Residual (GCR elliptic solver with preconditioner.

  4. A Matlab-based finite-difference solver for the Poisson problem with mixed Dirichlet-Neumann boundary conditions

    Science.gov (United States)

    Reimer, Ashton S.; Cheviakov, Alexei F.

    2013-03-01

    A Matlab-based finite-difference numerical solver for the Poisson equation for a rectangle and a disk in two dimensions, and a spherical domain in three dimensions, is presented. The solver is optimized for handling an arbitrary combination of Dirichlet and Neumann boundary conditions, and allows for full user control of mesh refinement. The solver routines utilize effective and parallelized sparse vector and matrix operations. Computations exhibit high speeds, numerical stability with respect to mesh size and mesh refinement, and acceptable error values even on desktop computers. Catalogue identifier: AENQ_v1_0 Program summary URL:http://cpc.cs.qub.ac.uk/summaries/AENQ_v1_0.html Program obtainable from: CPC Program Library, Queen's University, Belfast, N. Ireland Licensing provisions: GNU General Public License v3.0 No. of lines in distributed program, including test data, etc.: 102793 No. of bytes in distributed program, including test data, etc.: 369378 Distribution format: tar.gz Programming language: Matlab 2010a. Computer: PC, Macintosh. Operating system: Windows, OSX, Linux. RAM: 8 GB (8, 589, 934, 592 bytes) Classification: 4.3. Nature of problem: To solve the Poisson problem in a standard domain with “patchy surface”-type (strongly heterogeneous) Neumann/Dirichlet boundary conditions. Solution method: Finite difference with mesh refinement. Restrictions: Spherical domain in 3D; rectangular domain or a disk in 2D. Unusual features: Choice between mldivide/iterative solver for the solution of large system of linear algebraic equations that arise. Full user control of Neumann/Dirichlet boundary conditions and mesh refinement. Running time: Depending on the number of points taken and the geometry of the domain, the routine may take from less than a second to several hours to execute.

  5. Extending the Finite Domain Solver of GNU Prolog

    NARCIS (Netherlands)

    Bloemen, Vincent; Diaz, Daniel; van der Bijl, Machiel; Abreu, Salvador; Ströder, Thomas; Swift, Terrance

    This paper describes three significant extensions for the Finite Domain solver of GNU Prolog. First, the solver now supports negative integers. Second, the solver detects and prevents integer overflows from occurring. Third, the internal representation of sparse domains has been redesigned to

  6. Intrinsic shapes of discy and boxy ellipticals

    International Nuclear Information System (INIS)

    Fasano, Giovanni

    1991-01-01

    Statistical tests for intrinsic shapes of elliptical galaxies have given so far inconclusive and sometimes contradictory results. These failures have been often charged to the fact that classical tests consider only the two axisymmetric shapes (oblate versus prolate), while ellipticals are truly triaxial bodies. On the other hand, recent analyses indicate that the class of elliptical galaxies could be a mixture of (at least) two families having different morphology and dynamical behaviour: (i) a family of fast-rotating, disc-like ellipticals (discy); (ii) a family of slow-rotating, box-shaped ellipticals (boxy). In this paper we review the tests for instrinsic shapes of elliptical galaxies using data of better quality (CCD) with respect to previous applications. (author)

  7. Explicit solution of Calderon preconditioned time domain integral equations

    KAUST Repository

    Ulku, Huseyin Arda

    2013-07-01

    An explicit marching on-in-time (MOT) scheme for solving Calderon-preconditioned time domain integral equations is proposed. The scheme uses Rao-Wilton-Glisson and Buffa-Christiansen functions to discretize the domain and range of the integral operators and a PE(CE)m type linear multistep to march on in time. Unlike its implicit counterpart, the proposed explicit solver requires the solution of an MOT system with a Gram matrix that is sparse and well-conditioned independent of the time step size. Numerical results demonstrate that the explicit solver maintains its accuracy and stability even when the time step size is chosen as large as that typically used by an implicit solver. © 2013 IEEE.

  8. Shallow-water sloshing in a moving vessel with variable cross-section and wetting-drying using an extension of George's well-balanced finite volume solver

    Science.gov (United States)

    Alemi Ardakani, Hamid; Bridges, Thomas J.; Turner, Matthew R.

    2016-06-01

    A class of augmented approximate Riemann solvers due to George (2008) [12] is extended to solve the shallow-water equations in a moving vessel with variable bottom topography and variable cross-section with wetting and drying. A class of Roe-type upwind solvers for the system of balance laws is derived which respects the steady-state solutions. The numerical solutions of the new adapted augmented f-wave solvers are validated against the Roe-type solvers. The theory is extended to solve the shallow-water flows in moving vessels with arbitrary cross-section with influx-efflux boundary conditions motivated by the shallow-water sloshing in the ocean wave energy converter (WEC) proposed by Offshore Wave Energy Ltd. (OWEL) [1]. A fractional step approach is used to handle the time-dependent forcing functions. The numerical solutions are compared to an extended new Roe-type solver for the system of balance laws with a time-dependent source function. The shallow-water sloshing finite volume solver can be coupled to a Runge-Kutta integrator for the vessel motion.

  9. Lipschitz Regularity of Solutions for Mixed Integro-Differential Equations

    OpenAIRE

    Barles, Guy; Chasseigne, Emmanuel; Ciomaga, Adina; Imbert, Cyril

    2011-01-01

    We establish new Hoelder and Lipschitz estimates for viscosity solutions of a large class of elliptic and parabolic nonlinear integro-differential equations, by the classical Ishii-Lions's method. We thus extend the Hoelder regularity results recently obtained by Barles, Chasseigne and Imbert (2011). In addition, we deal with a new class of nonlocal equations that we term mixed integro-differential equations. These equations are particularly interesting, as they are degenerate both in the loc...

  10. Solving Coupled Gross--Pitaevskii Equations on a Cluster of PlayStation 3 Computers

    Science.gov (United States)

    Edwards, Mark; Heward, Jeffrey; Clark, C. W.

    2009-05-01

    At Georgia Southern University we have constructed an 8+1--node cluster of Sony PlayStation 3 (PS3) computers with the intention of using this computing resource to solve problems related to the behavior of ultra--cold atoms in general with a particular emphasis on studying bose--bose and bose--fermi mixtures confined in optical lattices. As a first project that uses this computing resource, we have implemented a parallel solver of the coupled time--dependent, one--dimensional Gross--Pitaevskii (TDGP) equations. These equations govern the behavior of dual-- species bosonic mixtures. We chose the split--operator/FFT to solve the coupled 1D TDGP equations. The fast Fourier transform component of this solver can be readily parallelized on the PS3 cpu known as the Cell Broadband Engine (CellBE). Each CellBE chip contains a single 64--bit PowerPC Processor Element known as the PPE and eight ``Synergistic Processor Element'' identified as the SPE's. We report on this algorithm and compare its performance to a non--parallel solver as applied to modeling evaporative cooling in dual--species bosonic mixtures.

  11. Preconditioning for Mixed Finite Element Formulations of Elliptic Problems

    KAUST Repository

    Wildey, Tim; Xue, Guangri

    2013-01-01

    In this paper, we discuss a preconditioning technique for mixed finite element discretizations of elliptic equations. The technique is based on a block-diagonal approximation of the mass matrix which maintains the sparsity and positive definiteness of the corresponding Schur complement. This preconditioner arises from the multipoint flux mixed finite element method and is robust with respect to mesh size and is better conditioned for full permeability tensors than a preconditioner based on a diagonal approximation of the mass matrix. © Springer-Verlag Berlin Heidelberg 2013.

  12. Elliptic solutions of generalized Brans-Dicke gravity with a non-universal coupling

    Energy Technology Data Exchange (ETDEWEB)

    Alimi, J.M.; Reverdy, V. [Observatoire de Paris, Laboratoire Univers et Theories (LUTh), Meudon (France); Golubtsova, A.A. [Observatoire de Paris, Laboratoire Univers et Theories (LUTh), Meudon (France); Peoples' Friendship University of Russia, Institute of Gravitation and Cosmology, Moscow (Russian Federation)

    2014-10-15

    We study a model of the generalized Brans-Dicke gravity presented in both the Jordan and in the Einstein frames, which are conformally related. We show that the scalar field equations in the Einstein frame are reduced to the geodesics equations on the target space of the nonlinear sigma model. The analytical solutions in elliptical functions are obtained when the conformal couplings are given by reciprocal exponential functions. The behavior of the scale factor in the Jordan frame is studied using numerical computations. For certain parameters the solutions can describe an accelerated expansion. We also derive an analytical approximation in exponential functions. (orig.)

  13. The properties of radio ellipticals

    International Nuclear Information System (INIS)

    Sparks, W.B.; Disney, M.J.; Rodgers, A.W.

    1984-01-01

    Optical and additional radio data are presented for the bright galaxies of the Disney and Wall survey (1977 Mon. Not. R. Astron. Soc. 179, 235). These data form the basis of a statistical comparison of the properties of radio elliptical galaxies to radio-quiet ellipticals. The correlations may be explained by the depth of the gravitational potential well in which the galaxy resides governing the circumstances under which an elliptical galaxy rids itself of internally produced gas. (author)

  14. The matrix nonlinear Schrodinger equation in dimension 2

    DEFF Research Database (Denmark)

    Zuhan, L; Pedersen, Michael

    2001-01-01

    In this paper we study the existence of global solutions to the Cauchy problem for the matrix nonlinear Schrodinger equation (MNLS) in 2 space dimensions. A sharp condition for the global existence is obtained for this equation. This condition is in terms of an exact stationary solution...... of a semilinear elliptic equation. In the scalar case, the MNLS reduces to the well-known cubic nonlinear Schrodinger equation for which existence of solutions has been studied by many authors. (C) 2001 Academic Press....

  15. Excursion Processes Associated with Elliptic Combinatorics

    Science.gov (United States)

    Baba, Hiroya; Katori, Makoto

    2018-06-01

    Researching elliptic analogues for equalities and formulas is a new trend in enumerative combinatorics which has followed the previous trend of studying q-analogues. Recently Schlosser proposed a lattice path model in the square lattice with a family of totally elliptic weight-functions including several complex parameters and discussed an elliptic extension of the binomial theorem. In the present paper, we introduce a family of discrete-time excursion processes on Z starting from the origin and returning to the origin in a given time duration 2 T associated with Schlosser's elliptic combinatorics. The processes are inhomogeneous both in space and time and hence expected to provide new models in non-equilibrium statistical mechanics. By numerical calculation we show that the maximum likelihood trajectories on the spatio-temporal plane of the elliptic excursion processes and of their reduced trigonometric versions are not straight lines in general but are nontrivially curved depending on parameters. We analyze asymptotic probability laws in the long-term limit T → ∞ for a simplified trigonometric version of excursion process. Emergence of nontrivial curves of trajectories in a large scale of space and time from the elementary elliptic weight-functions exhibits a new aspect of elliptic combinatorics.

  16. The elliptic genus and Hidden symmetry

    International Nuclear Information System (INIS)

    Jaffe, A.

    2001-01-01

    We study the elliptic genus (a partition function) in certain interacting, twist quantum field theories. Without twists, these theories have N=2 supersymmetry. The twists provide a regularization, and also partially break the supersymmetry. In spite of the regularization, one can establish a homotopy of the elliptic genus in a coupling parameter. Our construction relies on a priori estimates and other methods from constructive quantum field theory; this mathematical underpinning allows us to justify evaluating the elliptic genus at one endpoint of the homotopy. We obtain a version of Witten's proposed formula for the elliptic genus in terms of classical theta functions. As a consequence, the elliptic genus has a hidden SL(2,Z) symmetry characteristic of conformal theory, even though the underlying theory is not conformal. (orig.)

  17. Multicolor surface photometry of 17 ellipticals

    International Nuclear Information System (INIS)

    Franx, M.; Illingworth, G.; Heckman, T.

    1989-01-01

    Multicolor two-dimensional surface photometry was used to obtain radial profiles for surface brightness, color, ellipticity, position angle, and the residuals from the fitted ellipses described by the cos(n phi) and sin(n phi) terms (where n = 3 and 4) for 17 elliptical galaxies. It is found that at radii as large as five times the seeing FWHM, seeing can affect the ellipticity at the 10 percent level and introduce uncertainty in the position angles of several degrees, particularly for very round ellipticals. The present profiles are found to agree well with previous data, with rms differences of 0.02 in ellipticity and 2 deg in position angle. The observed color gradients are consistent with a decrease in the metallicity by a factor of about 2 per decade in radius. 61 refs

  18. The wake field acceleration using a cavity of elliptical cross section, part 1: WELL

    International Nuclear Information System (INIS)

    Chin, Yongho.

    1983-11-01

    A computer code WELL is developed for the calculation of the wake fields in a cavity of elliptical cross section. The method is basically an extention of that of BCI to the 3-dimensional computation, i.e., Maxwell's equations are solved in the time domain with boundary conditions. Open boundary conditions are used so as to simulate infinitely long beam pipes. Good agreements within a few percents are shown between the results of the computation by WELL and BCI in a cylindrically symmetrical structure. An example of computation in an elliptical structure gives a reasonable result and points out that the deflection of particles by the transverse wake field is severe. (author)

  19. From ordinary to partial differential equations

    CERN Document Server

    Esposito, Giampiero

    2017-01-01

    This book is addressed to mathematics and physics students who want to develop an interdisciplinary view of mathematics, from the age of Riemann, Poincaré and Darboux to basic tools of modern mathematics. It enables them to acquire the sensibility necessary for the formulation and solution of difficult problems, with an emphasis on concepts, rigour and creativity. It consists of eight self-contained parts: ordinary differential equations; linear elliptic equations; calculus of variations; linear and non-linear hyperbolic equations; parabolic equations; Fuchsian functions and non-linear equations; the functional equations of number theory; pseudo-differential operators and pseudo-differential equations. The author leads readers through the original papers and introduces new concepts, with a selection of topics and examples that are of high pedagogical value.

  20. A higher-order conservation element solution element method for solving hyperbolic differential equations on unstructured meshes

    Science.gov (United States)

    Bilyeu, David

    This dissertation presents an extension of the Conservation Element Solution Element (CESE) method from second- to higher-order accuracy. The new method retains the favorable characteristics of the original second-order CESE scheme, including (i) the use of the space-time integral equation for conservation laws, (ii) a compact mesh stencil, (iii) the scheme will remain stable up to a CFL number of unity, (iv) a fully explicit, time-marching integration scheme, (v) true multidimensionality without using directional splitting, and (vi) the ability to handle two- and three-dimensional geometries by using unstructured meshes. This algorithm has been thoroughly tested in one, two and three spatial dimensions and has been shown to obtain the desired order of accuracy for solving both linear and non-linear hyperbolic partial differential equations. The scheme has also shown its ability to accurately resolve discontinuities in the solutions. Higher order unstructured methods such as the Discontinuous Galerkin (DG) method and the Spectral Volume (SV) methods have been developed for one-, two- and three-dimensional application. Although these schemes have seen extensive development and use, certain drawbacks of these methods have been well documented. For example, the explicit versions of these two methods have very stringent stability criteria. This stability criteria requires that the time step be reduced as the order of the solver increases, for a given simulation on a given mesh. The research presented in this dissertation builds upon the work of Chang, who developed a fourth-order CESE scheme to solve a scalar one-dimensional hyperbolic partial differential equation. The completed research has resulted in two key deliverables. The first is a detailed derivation of a high-order CESE methods on unstructured meshes for solving the conservation laws in two- and three-dimensional spaces. The second is the code implementation of these numerical methods in a computer code. For