WorldWideScience

Sample records for algebraic multigrid algorithm

  1. Toward robust scalable algebraic multigrid solvers

    International Nuclear Information System (INIS)

    Waisman, Haim; Schroder, Jacob; Olson, Luke; Hiriyur, Badri; Gaidamour, Jeremie; Siefert, Christopher; Hu, Jonathan Joseph; Tuminaro, Raymond Stephen

    2010-01-01

    This talk highlights some multigrid challenges that arise from several application areas including structural dynamics, fluid flow, and electromagnetics. A general framework is presented to help introduce and understand algebraic multigrid methods based on energy minimization concepts. Connections between algebraic multigrid prolongators and finite element basis functions are made to explored. It is shown how the general algebraic multigrid framework allows one to adapt multigrid ideas to a number of different situations. Examples are given corresponding to linear elasticity and specifically in the solution of linear systems associated with extended finite elements for fracture problems.

  2. The development of an algebraic multigrid algorithm for symmetric positive definite linear systems

    Energy Technology Data Exchange (ETDEWEB)

    Vanek, P.; Mandel, J.; Brezina, M. [Univ. of Colorado, Denver, CO (United States)

    1996-12-31

    An algebraic multigrid algorithm for symmetric, positive definite linear systems is developed based on the concept of prolongation by smoothed aggregation. Coarse levels are generated automatically. We present a set of requirements motivated heuristically by a convergence theory. The algorithm then attempts to satisfy the requirements. Input to the method are the coefficient matrix and zero energy modes, which are determined from nodal coordinates and knowledge of the differential equation. Efficiency of the resulting algorithm is demonstrated by computational results on real world problems from solid elasticity, plate blending, and shells.

  3. Large-Scale Parallel Viscous Flow Computations using an Unstructured Multigrid Algorithm

    Science.gov (United States)

    Mavriplis, Dimitri J.

    1999-01-01

    The development and testing of a parallel unstructured agglomeration multigrid algorithm for steady-state aerodynamic flows is discussed. The agglomeration multigrid strategy uses a graph algorithm to construct the coarse multigrid levels from the given fine grid, similar to an algebraic multigrid approach, but operates directly on the non-linear system using the FAS (Full Approximation Scheme) approach. The scalability and convergence rate of the multigrid algorithm are examined on the SGI Origin 2000 and the Cray T3E. An argument is given which indicates that the asymptotic scalability of the multigrid algorithm should be similar to that of its underlying single grid smoothing scheme. For medium size problems involving several million grid points, near perfect scalability is obtained for the single grid algorithm, while only a slight drop-off in parallel efficiency is observed for the multigrid V- and W-cycles, using up to 128 processors on the SGI Origin 2000, and up to 512 processors on the Cray T3E. For a large problem using 25 million grid points, good scalability is observed for the multigrid algorithm using up to 1450 processors on a Cray T3E, even when the coarsest grid level contains fewer points than the total number of processors.

  4. 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.

  5. 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.

  6. Layout optimization with algebraic multigrid methods

    Science.gov (United States)

    Regler, Hans; Ruede, Ulrich

    1993-01-01

    Finding the optimal position for the individual cells (also called functional modules) on the chip surface is an important and difficult step in the design of integrated circuits. This paper deals with the problem of relative placement, that is the minimization of a quadratic functional with a large, sparse, positive definite system matrix. The basic optimization problem must be augmented by constraints to inhibit solutions where cells overlap. Besides classical iterative methods, based on conjugate gradients (CG), we show that algebraic multigrid methods (AMG) provide an interesting alternative. For moderately sized examples with about 10000 cells, AMG is already competitive with CG and is expected to be superior for larger problems. Besides the classical 'multiplicative' AMG algorithm where the levels are visited sequentially, we propose an 'additive' variant of AMG where levels may be treated in parallel and that is suitable as a preconditioner in the CG algorithm.

  7. A survey of parallel multigrid algorithms

    Science.gov (United States)

    Chan, Tony F.; Tuminaro, Ray S.

    1987-01-01

    A typical multigrid algorithm applied to well-behaved linear-elliptic partial-differential equations (PDEs) is described. Criteria for designing and evaluating parallel algorithms are presented. Before evaluating the performance of some parallel multigrid algorithms, consideration is given to some theoretical complexity results for solving PDEs in parallel and for executing the multigrid algorithm. The effect of mapping and load imbalance on the partial efficiency of the algorithm is studied.

  8. Analysis of a parallel multigrid algorithm

    Science.gov (United States)

    Chan, Tony F.; Tuminaro, Ray S.

    1989-01-01

    The parallel multigrid algorithm of Frederickson and McBryan (1987) is considered. This algorithm uses multiple coarse-grid problems (instead of one problem) in the hope of accelerating convergence and is found to have a close relationship to traditional multigrid methods. Specifically, the parallel coarse-grid correction operator is identical to a traditional multigrid coarse-grid correction operator, except that the mixing of high and low frequencies caused by aliasing error is removed. Appropriate relaxation operators can be chosen to take advantage of this property. Comparisons between the standard multigrid and the new method are made.

  9. High Performance Parallel Multigrid Algorithms for Unstructured Grids

    Science.gov (United States)

    Frederickson, Paul O.

    1996-01-01

    We describe a high performance parallel multigrid algorithm for a rather general class of unstructured grid problems in two and three dimensions. The algorithm PUMG, for parallel unstructured multigrid, is related in structure to the parallel multigrid algorithm PSMG introduced by McBryan and Frederickson, for they both obtain a higher convergence rate through the use of multiple coarse grids. Another reason for the high convergence rate of PUMG is its smoother, an approximate inverse developed by Baumgardner and Frederickson.

  10. Discrete Fourier analysis of multigrid algorithms

    NARCIS (Netherlands)

    van der Vegt, Jacobus J.W.; Rhebergen, Sander

    2011-01-01

    The main topic of this report is a detailed discussion of the discrete Fourier multilevel analysis of multigrid algorithms. First, a brief overview of multigrid methods is given for discretizations of both linear and nonlinear partial differential equations. Special attention is given to the

  11. Mapping robust parallel multigrid algorithms to scalable memory architectures

    Science.gov (United States)

    Overman, Andrea; Vanrosendale, John

    1993-01-01

    The convergence rate of standard multigrid algorithms degenerates on problems with stretched grids or anisotropic operators. The usual cure for this is the use of line or plane relaxation. However, multigrid algorithms based on line and plane relaxation have limited and awkward parallelism and are quite difficult to map effectively to highly parallel architectures. Newer multigrid algorithms that overcome anisotropy through the use of multiple coarse grids rather than relaxation are better suited to massively parallel architectures because they require only simple point-relaxation smoothers. In this paper, we look at the parallel implementation of a V-cycle multiple semicoarsened grid (MSG) algorithm on distributed-memory architectures such as the Intel iPSC/860 and Paragon computers. The MSG algorithms provide two levels of parallelism: parallelism within the relaxation or interpolation on each grid and across the grids on each multigrid level. Both levels of parallelism must be exploited to map these algorithms effectively to parallel architectures. This paper describes a mapping of an MSG algorithm to distributed-memory architectures that demonstrates how both levels of parallelism can be exploited. The result is a robust and effective multigrid algorithm for distributed-memory machines.

  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. Some multigrid algorithms for SIMD machines

    Energy Technology Data Exchange (ETDEWEB)

    Dendy, J.E. Jr. [Los Alamos National Lab., NM (United States)

    1996-12-31

    Previously a semicoarsening multigrid algorithm suitable for use on SIMD architectures was investigated. Through the use of new software tools, the performance of this algorithm has been considerably improved. The method has also been extended to three space dimensions. The method performs well for strongly anisotropic problems and for problems with coefficients jumping by orders of magnitude across internal interfaces. The parallel efficiency of this method is analyzed, and its actual performance on the CM-5 is compared with its performance on the CRAY-YMP. A standard coarsening multigrid algorithm is also considered, and we compare its performance on these two platforms as well.

  14. Three-dimensional forward modeling of DC resistivity using the aggregation-based algebraic multigrid method

    Science.gov (United States)

    Chen, Hui; Deng, Ju-Zhi; Yin, Min; Yin, Chang-Chun; Tang, Wen-Wu

    2017-03-01

    To speed up three-dimensional (3D) DC resistivity modeling, we present a new multigrid method, the aggregation-based algebraic multigrid method (AGMG). We first discretize the differential equation of the secondary potential field with mixed boundary conditions by using a seven-point finite-difference method to obtain a large sparse system of linear equations. Then, we introduce the theory behind the pairwise aggregation algorithms for AGMG and use the conjugate-gradient method with the V-cycle AGMG preconditioner (AGMG-CG) to solve the linear equations. We use typical geoelectrical models to test the proposed AGMG-CG method and compare the results with analytical solutions and the 3DDCXH algorithm for 3D DC modeling (3DDCXH). In addition, we apply the AGMG-CG method to different grid sizes and geoelectrical models and compare it to different iterative methods, such as ILU-BICGSTAB, ILU-GCR, and SSOR-CG. The AGMG-CG method yields nearly linearly decreasing errors, whereas the number of iterations increases slowly with increasing grid size. The AGMG-CG method is precise and converges fast, and thus can improve the computational efficiency in forward modeling of three-dimensional DC resistivity.

  15. New multigrid solver advances in TOPS

    International Nuclear Information System (INIS)

    Falgout, R D; Brannick, J; Brezina, M; Manteuffel, T; McCormick, S

    2005-01-01

    In this paper, we highlight new multigrid solver advances in the Terascale Optimal PDE Simulations (TOPS) project in the Scientific Discovery Through Advanced Computing (SciDAC) program. We discuss two new algebraic multigrid (AMG) developments in TOPS: the adaptive smoothed aggregation method (αSA) and a coarse-grid selection algorithm based on compatible relaxation (CR). The αSA method is showing promising results in initial studies for Quantum Chromodynamics (QCD) applications. The CR method has the potential to greatly improve the applicability of AMG

  16. Algebraic multigrid preconditioners for two-phase flow in porous media with phase transitions

    Science.gov (United States)

    Bui, Quan M.; Wang, Lu; Osei-Kuffuor, Daniel

    2018-04-01

    Multiphase flow is a critical process in a wide range of applications, including oil and gas recovery, carbon sequestration, and contaminant remediation. Numerical simulation of multiphase flow requires solving of a large, sparse linear system resulting from the discretization of the partial differential equations modeling the flow. In the case of multiphase multicomponent flow with miscible effect, this is a very challenging task. The problem becomes even more difficult if phase transitions are taken into account. A new approach to handle phase transitions is to formulate the system as a nonlinear complementarity problem (NCP). Unlike in the primary variable switching technique, the set of primary variables in this approach is fixed even when there is phase transition. Not only does this improve the robustness of the nonlinear solver, it opens up the possibility to use multigrid methods to solve the resulting linear system. The disadvantage of the complementarity approach, however, is that when a phase disappears, the linear system has the structure of a saddle point problem and becomes indefinite, and current algebraic multigrid (AMG) algorithms cannot be applied directly. In this study, we explore the effectiveness of a new multilevel strategy, based on the multigrid reduction technique, to deal with problems of this type. We demonstrate the effectiveness of the method through numerical results for the case of two-phase, two-component flow with phase appearance/disappearance. We also show that the strategy is efficient and scales optimally with problem size.

  17. Comparative Performance Analysis of Coarse Solvers for Algebraic Multigrid on Multicore and Manycore Architectures

    Energy Technology Data Exchange (ETDEWEB)

    Druinsky, A; Ghysels, P; Li, XS; Marques, O; Williams, S; Barker, A; Kalchev, D; Vassilevski, P

    2016-04-02

    In this paper, we study the performance of a two-level algebraic-multigrid algorithm, with a focus on the impact of the coarse-grid solver on performance. We consider two algorithms for solving the coarse-space systems: the preconditioned conjugate gradient method and a new robust HSS-embedded low-rank sparse-factorization algorithm. Our test data comes from the SPE Comparative Solution Project for oil-reservoir simulations. We contrast the performance of our code on one 12-core socket of a Cray XC30 machine with performance on a 60-core Intel Xeon Phi coprocessor. To obtain top performance, we optimized the code to take full advantage of fine-grained parallelism and made it thread-friendly for high thread count. We also developed a bounds-and-bottlenecks performance model of the solver which we used to guide us through the optimization effort, and also carried out performance tuning in the solver’s large parameter space. Finally, as a result, significant speedups were obtained on both machines.

  18. Two-Level Adaptive Algebraic Multigrid for a Sequence of Problems with Slowly Varying Random Coefficients [Adaptive Algebraic Multigrid for Sequence of Problems with Slowly Varying Random Coefficients

    Energy Technology Data Exchange (ETDEWEB)

    Kalchev, D. [Lawrence Livermore National Lab. (LLNL), Livermore, CA (United States); Ketelsen, C. [Lawrence Livermore National Lab. (LLNL), Livermore, CA (United States); Vassilevski, P. S. [Lawrence Livermore National Lab. (LLNL), Livermore, CA (United States)

    2013-11-07

    Our paper proposes an adaptive strategy for reusing a previously constructed coarse space by algebraic multigrid to construct a two-level solver for a problem with nearby characteristics. Furthermore, a main target application is the solution of the linear problems that appear throughout a sequence of Markov chain Monte Carlo simulations of subsurface flow with uncertain permeability field. We demonstrate the efficacy of the method with extensive set of numerical experiments.

  19. HP-multigrid as smoother algorithm for higher order discontinuous Galerkin discretizations of advection dominated flows. Part I. Multilevel Analysis

    NARCIS (Netherlands)

    van der Vegt, Jacobus J.W.; Rhebergen, Sander

    2011-01-01

    The hp-Multigrid as Smoother algorithm (hp-MGS) for the solution of higher order accurate space-(time) discontinuous Galerkin discretizations of advection dominated flows is presented. This algorithm combines p-multigrid with h-multigrid at all p-levels, where the h-multigrid acts as smoother in the

  20. Algorithms in Algebraic Geometry

    CERN Document Server

    Dickenstein, Alicia; Sommese, Andrew J

    2008-01-01

    In the last decade, there has been a burgeoning of activity in the design and implementation of algorithms for algebraic geometric computation. Some of these algorithms were originally designed for abstract algebraic geometry, but now are of interest for use in applications and some of these algorithms were originally designed for applications, but now are of interest for use in abstract algebraic geometry. The workshop on Algorithms in Algebraic Geometry that was held in the framework of the IMA Annual Program Year in Applications of Algebraic Geometry by the Institute for Mathematics and Its

  1. Non-Galerkin Coarse Grids for Algebraic Multigrid

    Energy Technology Data Exchange (ETDEWEB)

    Falgout, Robert D. [Lawrence Livermore National Lab. (LLNL), Livermore, CA (United States); Schroder, Jacob B. [Lawrence Livermore National Lab. (LLNL), Livermore, CA (United States)

    2014-06-26

    Algebraic multigrid (AMG) is a popular and effective solver for systems of linear equations that arise from discretized partial differential equations. And while AMG has been effectively implemented on large scale parallel machines, challenges remain, especially when moving to exascale. Particularly, stencil sizes (the number of nonzeros in a row) tend to increase further down in the coarse grid hierarchy, and this growth leads to more communication. Therefore, as problem size increases and the number of levels in the hierarchy grows, the overall efficiency of the parallel AMG method decreases, sometimes dramatically. This growth in stencil size is due to the standard Galerkin coarse grid operator, $P^T A P$, where $P$ is the prolongation (i.e., interpolation) operator. For example, the coarse grid stencil size for a simple three-dimensional (3D) seven-point finite differencing approximation to diffusion can increase into the thousands on present day machines, causing an associated increase in communication costs. We therefore consider algebraically truncating coarse grid stencils to obtain a non-Galerkin coarse grid. First, the sparsity pattern of the non-Galerkin coarse grid is determined by employing a heuristic minimal “safe” pattern together with strength-of-connection ideas. Second, the nonzero entries are determined by collapsing the stencils in the Galerkin operator using traditional AMG techniques. The result is a reduction in coarse grid stencil size, overall operator complexity, and parallel AMG solve phase times.

  2. Multigrid Methods for Fully Implicit Oil Reservoir Simulation

    Science.gov (United States)

    Molenaar, J.

    1996-01-01

    In this paper we consider the simultaneous flow of oil and water in reservoir rock. This displacement process is modeled by two basic equations: the material balance or continuity equations and the equation of motion (Darcy's law). For the numerical solution of this system of nonlinear partial differential equations there are two approaches: the fully implicit or simultaneous solution method and the sequential solution method. In the sequential solution method the system of partial differential equations is manipulated to give an elliptic pressure equation and a hyperbolic (or parabolic) saturation equation. In the IMPES approach the pressure equation is first solved, using values for the saturation from the previous time level. Next the saturations are updated by some explicit time stepping method; this implies that the method is only conditionally stable. For the numerical solution of the linear, elliptic pressure equation multigrid methods have become an accepted technique. On the other hand, the fully implicit method is unconditionally stable, but it has the disadvantage that in every time step a large system of nonlinear algebraic equations has to be solved. The most time-consuming part of any fully implicit reservoir simulator is the solution of this large system of equations. Usually this is done by Newton's method. The resulting systems of linear equations are then either solved by a direct method or by some conjugate gradient type method. In this paper we consider the possibility of applying multigrid methods for the iterative solution of the systems of nonlinear equations. There are two ways of using multigrid for this job: either we use a nonlinear multigrid method or we use a linear multigrid method to deal with the linear systems that arise in Newton's method. So far only a few authors have reported on the use of multigrid methods for fully implicit simulations. Two-level FAS algorithm is presented for the black-oil equations, and linear multigrid for

  3. A multigrid algorithm for the cell-centered finite difference scheme

    Science.gov (United States)

    Ewing, Richard E.; Shen, Jian

    1993-01-01

    In this article, we discuss a non-variational V-cycle multigrid algorithm based on the cell-centered finite difference scheme for solving a second-order elliptic problem with discontinuous coefficients. Due to the poor approximation property of piecewise constant spaces and the non-variational nature of our scheme, one step of symmetric linear smoothing in our V-cycle multigrid scheme may fail to be a contraction. Again, because of the simple structure of the piecewise constant spaces, prolongation and restriction are trivial; we save significant computation time with very promising computational results.

  4. An evaluation of parallel multigrid as a solver and a preconditioner for singular perturbed problems

    Energy Technology Data Exchange (ETDEWEB)

    Oosterlee, C.W. [Inst. for Algorithms and Scientific Computing, Sankt Augustin (Germany); Washio, T. [C& C Research Lab., Sankt Augustin (Germany)

    1996-12-31

    In this paper we try to achieve h-independent convergence with preconditioned GMRES and BiCGSTAB for 2D singular perturbed equations. Three recently developed multigrid methods are adopted as a preconditioner. They are also used as solution methods in order to compare the performance of the methods as solvers and as preconditioners. Two of the multigrid methods differ only in the transfer operators. One uses standard matrix- dependent prolongation operators from. The second uses {open_quotes}upwind{close_quotes} prolongation operators, developed. Both employ the Galerkin coarse grid approximation and an alternating zebra line Gauss-Seidel smoother. The third method is based on the block LU decomposition of a matrix and on an approximate Schur complement. This multigrid variant is presented in. All three multigrid algorithms are algebraic methods.

  5. Semi-coarsening multigrid methods for parallel computing

    Energy Technology Data Exchange (ETDEWEB)

    Jones, J.E.

    1996-12-31

    Standard multigrid methods are not well suited for problems with anisotropic coefficients which can occur, for example, on grids that are stretched to resolve a boundary layer. There are several different modifications of the standard multigrid algorithm that yield efficient methods for anisotropic problems. In the paper, we investigate the parallel performance of these multigrid algorithms. Multigrid algorithms which work well for anisotropic problems are based on line relaxation and/or semi-coarsening. In semi-coarsening multigrid algorithms a grid is coarsened in only one of the coordinate directions unlike standard or full-coarsening multigrid algorithms where a grid is coarsened in each of the coordinate directions. When both semi-coarsening and line relaxation are used, the resulting multigrid algorithm is robust and automatic in that it requires no knowledge of the nature of the anisotropy. This is the basic multigrid algorithm whose parallel performance we investigate in the paper. The algorithm is currently being implemented on an IBM SP2 and its performance is being analyzed. In addition to looking at the parallel performance of the basic semi-coarsening algorithm, we present algorithmic modifications with potentially better parallel efficiency. One modification reduces the amount of computational work done in relaxation at the expense of using multiple coarse grids. This modification is also being implemented with the aim of comparing its performance to that of the basic semi-coarsening algorithm.

  6. Recent Development of Multigrid Algorithms for Mixed and Noncomforming Methods for Second Order Elliptical Problems

    Science.gov (United States)

    Chen, Zhangxin; Ewing, Richard E.

    1996-01-01

    Multigrid algorithms for nonconforming and mixed finite element methods for second order elliptic problems on triangular and rectangular finite elements are considered. The construction of several coarse-to-fine intergrid transfer operators for nonconforming multigrid algorithms is discussed. The equivalence between the nonconforming and mixed finite element methods with and without projection of the coefficient of the differential problems into finite element spaces is described.

  7. Advanced Algebraic Multigrid Solvers for Subsurface Flow Simulation

    KAUST Repository

    Chen, Meng-Huo

    2015-09-13

    In this research we are particularly interested in extending the robustness of multigrid solvers to encounter complex systems related to subsurface reservoir applications for flow problems in porous media. In many cases, the step for solving the pressure filed in subsurface flow simulation becomes a bottleneck for the performance of the simulator. For solving large sparse linear system arising from MPFA discretization, we choose multigrid methods as the linear solver. The possible difficulties and issues will be addressed and the corresponding remedies will be studied. As the multigrid methods are used as the linear solver, the simulator can be parallelized (although not trivial) and the high-resolution simulation become feasible, the ultimately goal which we desire to achieve.

  8. Adaptive Multigrid Algorithm for the Lattice Wilson-Dirac Operator

    International Nuclear Information System (INIS)

    Babich, R.; Brower, R. C.; Rebbi, C.; Brannick, J.; Clark, M. A.; Manteuffel, T. A.; McCormick, S. F.; Osborn, J. C.

    2010-01-01

    We present an adaptive multigrid solver for application to the non-Hermitian Wilson-Dirac system of QCD. The key components leading to the success of our proposed algorithm are the use of an adaptive projection onto coarse grids that preserves the near null space of the system matrix together with a simplified form of the correction based on the so-called γ 5 -Hermitian symmetry of the Dirac operator. We demonstrate that the algorithm nearly eliminates critical slowing down in the chiral limit and that it has weak dependence on the lattice volume.

  9. Electrical Resistivity Tomography using a finite element based BFGS algorithm with algebraic multigrid preconditioning

    Science.gov (United States)

    Codd, A. L.; Gross, L.

    2018-03-01

    We present a new inversion method for Electrical Resistivity Tomography which, in contrast to established approaches, minimizes the cost function prior to finite element discretization for the unknown electric conductivity and electric potential. Minimization is performed with the Broyden-Fletcher-Goldfarb-Shanno method (BFGS) in an appropriate function space. BFGS is self-preconditioning and avoids construction of the dense Hessian which is the major obstacle to solving large 3-D problems using parallel computers. In addition to the forward problem predicting the measurement from the injected current, the so-called adjoint problem also needs to be solved. For this problem a virtual current is injected through the measurement electrodes and an adjoint electric potential is obtained. The magnitude of the injected virtual current is equal to the misfit at the measurement electrodes. This new approach has the advantage that the solution process of the optimization problem remains independent to the meshes used for discretization and allows for mesh adaptation during inversion. Computation time is reduced by using superposition of pole loads for the forward and adjoint problems. A smoothed aggregation algebraic multigrid (AMG) preconditioned conjugate gradient is applied to construct the potentials for a given electric conductivity estimate and for constructing a first level BFGS preconditioner. Through the additional reuse of AMG operators and coarse grid solvers inversion time for large 3-D problems can be reduced further. We apply our new inversion method to synthetic survey data created by the resistivity profile representing the characteristics of subsurface fluid injection. We further test it on data obtained from a 2-D surface electrode survey on Heron Island, a small tropical island off the east coast of central Queensland, Australia.

  10. A parallel version of a multigrid algorithm for isotropic transport equations

    International Nuclear Information System (INIS)

    Manteuffel, T.; McCormick, S.; Yang, G.; Morel, J.; Oliveira, S.

    1994-01-01

    The focus of this paper is on a parallel algorithm for solving the transport equations in a slab geometry using multigrid. The spatial discretization scheme used is a finite element method called the modified linear discontinuous (MLD) scheme. The MLD scheme represents a lumped version of the standard linear discontinuous (LD) scheme. The parallel algorithm was implemented on the Connection Machine 2 (CM2). Convergence rates and timings for this algorithm on the CM2 and Cray-YMP are shown

  11. An algorithm to construct the basic algebra of a skew group algebra

    NARCIS (Netherlands)

    Horobeţ, E.

    2016-01-01

    We give an algorithm for the computation of the basic algebra Morita equivalent to a skew group algebra of a path algebra by obtaining formulas for the number of vertices and arrows of the new quiver Qb. We apply this algorithm to compute the basic algebra corresponding to all simple quaternion

  12. Multigrid methods in structural mechanics

    Science.gov (United States)

    Raju, I. S.; Bigelow, C. A.; Taasan, S.; Hussaini, M. Y.

    1986-01-01

    Although the application of multigrid methods to the equations of elasticity has been suggested, few such applications have been reported in the literature. In the present work, multigrid techniques are applied to the finite element analysis of a simply supported Bernoulli-Euler beam, and various aspects of the multigrid algorithm are studied and explained in detail. In this study, six grid levels were used to model half the beam. With linear prolongation and sequential ordering, the multigrid algorithm yielded results which were of machine accuracy with work equivalent to 200 standard Gauss-Seidel iterations on the fine grid. Also with linear prolongation and sequential ordering, the V(1,n) cycle with n greater than 2 yielded better convergence rates than the V(n,1) cycle. The restriction and prolongation operators were derived based on energy principles. Conserving energy during the inter-grid transfers required that the prolongation operator be the transpose of the restriction operator, and led to improved convergence rates. With energy-conserving prolongation and sequential ordering, the multigrid algorithm yielded results of machine accuracy with a work equivalent to 45 Gauss-Seidel iterations on the fine grid. The red-black ordering of relaxations yielded solutions of machine accuracy in a single V(1,1) cycle, which required work equivalent to about 4 iterations on the finest grid level.

  13. Is the Multigrid Method Fault Tolerant? The Two-Grid Case

    Energy Technology Data Exchange (ETDEWEB)

    Ainsworth, Mark [Brown Univ., Providence, RI (United States). Division of Applied Mathematics; Oak Ridge National Lab. (ORNL), Oak Ridge, TN (United States). Computer Science and Mathematics Division; Glusa, Christian [Brown Univ., Providence, RI (United States). Division of Applied Mathematics

    2016-06-30

    The predicted reduced resiliency of next-generation high performance computers means that it will become necessary to take into account the effects of randomly occurring faults on numerical methods. Further, in the event of a hard fault occurring, a decision has to be made as to what remedial action should be taken in order to resume the execution of the algorithm. The action that is chosen can have a dramatic effect on the performance and characteristics of the scheme. Ideally, the resulting algorithm should be subjected to the same kind of mathematical analysis that was applied to the original, deterministic variant. The purpose of this work is to provide an analysis of the behaviour of the multigrid algorithm in the presence of faults. Multigrid is arguably the method of choice for the solution of large-scale linear algebra problems arising from discretization of partial differential equations and it is of considerable importance to anticipate its behaviour on an exascale machine. The analysis of resilience of algorithms is in its infancy and the current work is perhaps the first to provide a mathematical model for faults and analyse the behaviour of a state-of-the-art algorithm under the model. It is shown that the Two Grid Method fails to be resilient to faults. Attention is then turned to identifying the minimal necessary remedial action required to restore the rate of convergence to that enjoyed by the ideal fault-free method.

  14. Asynchronous Task-Based Parallelization of Algebraic Multigrid

    KAUST Repository

    AlOnazi, Amani A.

    2017-06-23

    As processor clock rates become more dynamic and workloads become more adaptive, the vulnerability to global synchronization that already complicates programming for performance in today\\'s petascale environment will be exacerbated. Algebraic multigrid (AMG), the solver of choice in many large-scale PDE-based simulations, scales well in the weak sense, with fixed problem size per node, on tightly coupled systems when loads are well balanced and core performance is reliable. However, its strong scaling to many cores within a node is challenging. Reducing synchronization and increasing concurrency are vital adaptations of AMG to hybrid architectures. Recent communication-reducing improvements to classical additive AMG by Vassilevski and Yang improve concurrency and increase communication-computation overlap, while retaining convergence properties close to those of standard multiplicative AMG, but remain bulk synchronous.We extend the Vassilevski and Yang additive AMG to asynchronous task-based parallelism using a hybrid MPI+OmpSs (from the Barcelona Supercomputer Center) within a node, along with MPI for internode communications. We implement a tiling approach to decompose the grid hierarchy into parallel units within task containers. We compare against the MPI-only BoomerAMG and the Auxiliary-space Maxwell Solver (AMS) in the hypre library for the 3D Laplacian operator and the electromagnetic diffusion, respectively. In time to solution for a full solve an MPI-OmpSs hybrid improves over an all-MPI approach in strong scaling at full core count (32 threads per single Haswell node of the Cray XC40) and maintains this per node advantage as both weak scale to thousands of cores, with MPI between nodes.

  15. Algebraic dynamics algorithm: Numerical comparison with Runge-Kutta algorithm and symplectic geometric algorithm

    Institute of Scientific and Technical Information of China (English)

    WANG ShunJin; ZHANG Hua

    2007-01-01

    Based on the exact analytical solution of ordinary differential equations,a truncation of the Taylor series of the exact solution to the Nth order leads to the Nth order algebraic dynamics algorithm.A detailed numerical comparison is presented with Runge-Kutta algorithm and symplectic geometric algorithm for 12 test models.The results show that the algebraic dynamics algorithm can better preserve both geometrical and dynamical fidelity of a dynamical system at a controllable precision,and it can solve the problem of algorithm-induced dissipation for the Runge-Kutta algorithm and the problem of algorithm-induced phase shift for the symplectic geometric algorithm.

  16. Algebraic dynamics algorithm:Numerical comparison with Runge-Kutta algorithm and symplectic geometric algorithm

    Institute of Scientific and Technical Information of China (English)

    2007-01-01

    Based on the exact analytical solution of ordinary differential equations, a truncation of the Taylor series of the exact solution to the Nth order leads to the Nth order algebraic dynamics algorithm. A detailed numerical comparison is presented with Runge-Kutta algorithm and symplectic geometric algorithm for 12 test models. The results show that the algebraic dynamics algorithm can better preserve both geometrical and dynamical fidelity of a dynamical system at a controllable precision, and it can solve the problem of algorithm-induced dissipation for the Runge-Kutta algorithm and the problem of algorithm-induced phase shift for the symplectic geometric algorithm.

  17. Algebraic dynamics solutions and algebraic dynamics algorithm for nonlinear ordinary differential equations

    Institute of Scientific and Technical Information of China (English)

    WANG; Shunjin; ZHANG; Hua

    2006-01-01

    The problem of preserving fidelity in numerical computation of nonlinear ordinary differential equations is studied in terms of preserving local differential structure and approximating global integration structure of the dynamical system.The ordinary differential equations are lifted to the corresponding partial differential equations in the framework of algebraic dynamics,and a new algorithm-algebraic dynamics algorithm is proposed based on the exact analytical solutions of the ordinary differential equations by the algebraic dynamics method.In the new algorithm,the time evolution of the ordinary differential system is described locally by the time translation operator and globally by the time evolution operator.The exact analytical piece-like solution of the ordinary differential equations is expressd in terms of Taylor series with a local convergent radius,and its finite order truncation leads to the new numerical algorithm with a controllable precision better than Runge Kutta Algorithm and Symplectic Geometric Algorithm.

  18. Advanced Algebraic Multigrid Solvers for Subsurface Flow Simulation

    KAUST Repository

    Chen, Meng-Huo; Sun, Shuyu; Salama, Amgad

    2015-01-01

    and issues will be addressed and the corresponding remedies will be studied. As the multigrid methods are used as the linear solver, the simulator can be parallelized (although not trivial) and the high-resolution simulation become feasible, the ultimately

  19. Unweighted least squares phase unwrapping by means of multigrid techniques

    Science.gov (United States)

    Pritt, Mark D.

    1995-11-01

    We present a multigrid algorithm for unweighted least squares phase unwrapping. This algorithm applies Gauss-Seidel relaxation schemes to solve the Poisson equation on smaller, coarser grids and transfers the intermediate results to the finer grids. This approach forms the basis of our multigrid algorithm for weighted least squares phase unwrapping, which is described in a separate paper. The key idea of our multigrid approach is to maintain the partial derivatives of the phase data in separate arrays and to correct these derivatives at the boundaries of the coarser grids. This maintains the boundary conditions necessary for rapid convergence to the correct solution. Although the multigrid algorithm is an iterative algorithm, we demonstrate that it is nearly as fast as the direct Fourier-based method. We also describe how to parallelize the algorithm for execution on a distributed-memory parallel processor computer or a network-cluster of workstations.

  20. Optimal multigrid algorithms for the massive Gaussian model and path integrals

    International Nuclear Information System (INIS)

    Brandt, A.; Galun, M.

    1996-01-01

    Multigrid algorithms are presented which, in addition to eliminating the critical slowing down, can also eliminate the open-quotes volume factorclose quotes. The elimination of the volume factor removes the need to produce many independent fine-grid configurations for averaging out their statistical deviations, by averaging over the many samples produced on coarse grids during the multigrid cycle. Thermodynamic limits of observables can be calculated to relative accuracy var-epsilon r in just O(var-epsilon r -2 ) computer operations, where var-epsilon r is the error relative to the standard deviation of the observable. In this paper, we describe in detail the calculation of the susceptibility in the one-dimensional massive Gaussian model, which is also a simple example of path integrals. Numerical experiments show that the susceptibility can be calculated to relative accuracy var-epsilon r in about 8 var-epsilon r -2 random number generations, independent of the mass size

  1. Highly indefinite multigrid for eigenvalue problems

    Energy Technology Data Exchange (ETDEWEB)

    Borges, L.; Oliveira, S.

    1996-12-31

    Eigenvalue problems are extremely important in understanding dynamic processes such as vibrations and control systems. Large scale eigenvalue problems can be very difficult to solve, especially if a large number of eigenvalues and the corresponding eigenvectors need to be computed. For solving this problem a multigrid preconditioned algorithm is presented in {open_quotes}The Davidson Algorithm, preconditioning and misconvergence{close_quotes}. Another approach for solving eigenvalue problems is by developing efficient solutions for highly indefinite problems. In this paper we concentrate on the use of new highly indefinite multigrid algorithms for the eigenvalue problem.

  2. 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.

  3. The Mixed Finite Element Multigrid Method for Stokes Equations

    Science.gov (United States)

    Muzhinji, K.; Shateyi, S.; Motsa, S. S.

    2015-01-01

    The stable finite element discretization of the Stokes problem produces a symmetric indefinite system of linear algebraic equations. A variety of iterative solvers have been proposed for such systems in an attempt to construct efficient, fast, and robust solution techniques. This paper investigates one of such iterative solvers, the geometric multigrid solver, to find the approximate solution of the indefinite systems. The main ingredient of the multigrid method is the choice of an appropriate smoothing strategy. This study considers the application of different smoothers and compares their effects in the overall performance of the multigrid solver. We study the multigrid method with the following smoothers: distributed Gauss Seidel, inexact Uzawa, preconditioned MINRES, and Braess-Sarazin type smoothers. A comparative study of the smoothers shows that the Braess-Sarazin smoothers enhance good performance of the multigrid method. We study the problem in a two-dimensional domain using stable Hood-Taylor Q 2-Q 1 pair of finite rectangular elements. We also give the main theoretical convergence results. We present the numerical results to demonstrate the efficiency and robustness of the multigrid method and confirm the theoretical results. PMID:25945361

  4. Multigrid Algorithms for the Solution of Linear Complementarity Problems Arising from Free Boundary Problems.

    Science.gov (United States)

    1980-10-01

    solving (1.3); PFAS combines the concepts of multigrid algorithms with those of projected SOR. In Section 3, we discuss the implementation of PFAS, and...numerique de la torsion elasto- plastique d’une barre cylindrique. In Approximation et Methodes Iteratives de Resolution d’Inequations Variationelles et

  5. Numerical Multilevel Upscaling for Incompressible Flow in Reservoir Simulation: An Element-based Algebraic Multigrid (AMGe) Approach

    DEFF Research Database (Denmark)

    Christensen, Max la Cour; Villa, Umberto; Engsig-Karup, Allan Peter

    2017-01-01

    associated with non-planar interfaces between agglomerates, the coarse velocity space has guaranteed approximation properties. The employed AMGe technique provides coarse spaces with desirable local mass conservation and stability properties analogous to the original pair of Raviart-Thomas and piecewise......We study the application of a finite element numerical upscaling technique to the incompressible two-phase porous media total velocity formulation. Specifically, an element agglomeration based Algebraic Multigrid (AMGe) technique with improved approximation proper ties [37] is used, for the first...... discontinuous polynomial spaces, resulting in strong mass conservation for the upscaled systems. Due to the guaranteed approximation properties and the generic nature of the AMGe method, recursive multilevel upscaling is automatically obtained. Furthermore, this technique works for both structured...

  6. HP-Multigrid as Smoother algorithm for higher order discontinuous Galerkin discretizations of advection dominated flows. Part II: Optimization of the Runge-Kutta smoother

    NARCIS (Netherlands)

    van der Vegt, Jacobus J.W.; Rhebergen, Sander

    2012-01-01

    Using a detailed multilevel analysis of the complete hp-Multigrid as Smoother algorithm accurate predictions are obtained of the spectral radius and operator norms of the multigrid error transformation operator. This multilevel analysis is used to optimize the coefficients in the semi-implicit

  7. Construction Example for Algebra System Using Harmony Search Algorithm

    Directory of Open Access Journals (Sweden)

    FangAn Deng

    2015-01-01

    Full Text Available The construction example of algebra system is to verify the existence of a complex algebra system, and it is a NP-hard problem. In this paper, to solve this kind of problems, firstly, a mathematical optimization model for construction example of algebra system is established. Secondly, an improved harmony search algorithm based on NGHS algorithm (INGHS is proposed to find as more solutions as possible for the optimization model; in the proposed INGHS algorithm, to achieve the balance between exploration power and exploitation power in the search process, a global best strategy and parameters dynamic adjustment method are present. Finally, nine construction examples of algebra system are used to evaluate the optimization model and performance of INGHS. The experimental results show that the proposed algorithm has strong performance for solving complex construction example problems of algebra system.

  8. Algebraic Algorithm Design and Local Search

    National Research Council Canada - National Science Library

    Graham, Robert

    1996-01-01

    .... Algebraic techniques have been applied successfully to algorithm synthesis by the use of algorithm theories and design tactics, an approach pioneered in the Kestrel Interactive Development System (KIDS...

  9. Progress with multigrid schemes for hypersonic flow problems

    International Nuclear Information System (INIS)

    Radespiel, R.; Swanson, R.C.

    1995-01-01

    Several multigrid schemes are considered for the numerical computation of viscous hypersonic flows. For each scheme, the basic solution algorithm employs upwind spatial discretization with explicit multistage time stepping. Two-level versions of the various multigrid algorithms are applied to the two-dimensional advection equation, and Fourier analysis is used to determine their damping properties. The capabilities of the multigrid methods are assessed by solving three different hypersonic flow problems. Some new multigrid schemes based on semicoarsening strategies are shown to be quite effective in relieving the stiffness caused by the high-aspect-ratio cells required to resolve high Reynolds number flows. These schemes exhibit good convergence rates for Reynolds numbers up to 200 X 10 6 and Mach numbers up to 25. 32 refs., 31 figs., 1 tab

  10. Homogeneous Buchberger algorithms and Sullivant's computational commutative algebra challenge

    DEFF Research Database (Denmark)

    Lauritzen, Niels

    2005-01-01

    We give a variant of the homogeneous Buchberger algorithm for positively graded lattice ideals. Using this algorithm we solve the Sullivant computational commutative algebra challenge.......We give a variant of the homogeneous Buchberger algorithm for positively graded lattice ideals. Using this algorithm we solve the Sullivant computational commutative algebra challenge....

  11. Final report on the Copper Mountain conference on multigrid methods

    Energy Technology Data Exchange (ETDEWEB)

    NONE

    1997-10-01

    The Copper Mountain Conference on Multigrid Methods was held on April 6-11, 1997. It took the same format used in the previous Copper Mountain Conferences on Multigrid Method conferences. Over 87 mathematicians from all over the world attended the meeting. 56 half-hour talks on current research topics were presented. Talks with similar content were organized into sessions. Session topics included: fluids; domain decomposition; iterative methods; basics; adaptive methods; non-linear filtering; CFD; applications; transport; algebraic solvers; supercomputing; and student paper winners.

  12. Design Considerations for a Flexible Multigrid Preconditioning Library

    Directory of Open Access Journals (Sweden)

    Jérémie Gaidamour

    2012-01-01

    Full Text Available MueLu is a library within the Trilinos software project [An overview of Trilinos, Technical Report SAND2003-2927, Sandia National Laboratories, 2003] and provides a framework for parallel multigrid preconditioning methods for large sparse linear systems. While providing efficient implementations of modern multigrid methods based on smoothed aggregation and energy minimization concepts, MueLu is designed to be customized and extended. This article gives an overview of design considerations for the MueLu package: user interfaces, internal design, data management, usage of modern software constructs, leveraging Trilinos capabilities, linear algebra operations and advanced application.

  13. Multigrid methods for partial differential equations - a short introduction

    International Nuclear Information System (INIS)

    Linden, J.; Stueben, K.

    1993-01-01

    These notes summarize the multigrid methods and emphasis is laid on the algorithmic concepts of multigrid for solving linear and non-linear partial differential equations. In this paper there is brief description of the basic structure of multigrid methods. Detailed introduction is also contained with applications to VLSI process simulation. (A.B.)

  14. Using Linear Algebra to Introduce Computer Algebra, Numerical Analysis, Data Structures and Algorithms (and To Teach Linear Algebra, Too).

    Science.gov (United States)

    Gonzalez-Vega, Laureano

    1999-01-01

    Using a Computer Algebra System (CAS) to help with the teaching of an elementary course in linear algebra can be one way to introduce computer algebra, numerical analysis, data structures, and algorithms. Highlights the advantages and disadvantages of this approach to the teaching of linear algebra. (Author/MM)

  15. Layer-oriented multigrid wavefront reconstruction algorithms for multi-conjugate adaptive optics

    Science.gov (United States)

    Gilles, Luc; Ellerbroek, Brent L.; Vogel, Curtis R.

    2003-02-01

    Multi-conjugate adaptive optics (MCAO) systems with 104-105 degrees of freedom have been proposed for future giant telescopes. Using standard matrix methods to compute, optimize, and implement wavefront control algorithms for these systems is impractical, since the number of calculations required to compute and apply the reconstruction matrix scales respectively with the cube and the square of the number of AO degrees of freedom. In this paper, we develop an iterative sparse matrix implementation of minimum variance wavefront reconstruction for telescope diameters up to 32m with more than 104 actuators. The basic approach is the preconditioned conjugate gradient method, using a multigrid preconditioner incorporating a layer-oriented (block) symmetric Gauss-Seidel iterative smoothing operator. We present open-loop numerical simulation results to illustrate algorithm convergence.

  16. Extending the applicability of multigrid methods

    International Nuclear Information System (INIS)

    Brannick, J; Brezina, M; Falgout, R; Manteuffel, T; McCormick, S; Ruge, J; Sheehan, B; Xu, J; Zikatanov, L

    2006-01-01

    Multigrid methods are ideal for solving the increasingly large-scale problems that arise in numerical simulations of physical phenomena because of their potential for computational costs and memory requirements that scale linearly with the degrees of freedom. Unfortunately, they have been historically limited by their applicability to elliptic-type problems and the need for special handling in their implementation. In this paper, we present an overview of several recent theoretical and algorithmic advances made by the TOPS multigrid partners and their collaborators in extending applicability of multigrid methods. specific examples that are presented include quantum chromodynamics, radiation transport, and electromagnetics

  17. Subroutine MLTGRD: a multigrid algorithm based on multiplicative correction and implicit non-stationary iteration

    International Nuclear Information System (INIS)

    Barry, J.M.; Pollard, J.P.

    1986-11-01

    A FORTRAN subroutine MLTGRD is provided to solve efficiently the large systems of linear equations arising from a five-point finite difference discretisation of some elliptic partial differential equations. MLTGRD is a multigrid algorithm which provides multiplicative correction to iterative solution estimates from successively reduced systems of linear equations. It uses the method of implicit non-stationary iteration for all grid levels

  18. Convergence analysis of variational and non-variational multigrid algorithms for the Laplace-Beltrami operator

    KAUST Repository

    Bonito, Andrea

    2012-09-01

    We design and analyze variational and non-variational multigrid algorithms for the Laplace-Beltrami operator on a smooth and closed surface. In both cases, a uniform convergence for the V -cycle algorithm is obtained provided the surface geometry is captured well enough by the coarsest grid. The main argument hinges on a perturbation analysis from an auxiliary variational algorithm defined directly on the smooth surface. In addition, the vanishing mean value constraint is imposed on each level, thereby avoiding singular quadratic forms without adding additional computational cost. Numerical results supporting our analysis are reported. In particular, the algorithms perform well even when applied to surfaces with a large aspect ratio. © 2011 American Mathematical Society.

  19. Algebraic dynamics solutions and algebraic dynamics algorithm for nonlinear partial differential evolution equations of dynamical systems

    Institute of Scientific and Technical Information of China (English)

    2008-01-01

    Using functional derivative technique in quantum field theory, the algebraic dy-namics approach for solution of ordinary differential evolution equations was gen-eralized to treat partial differential evolution equations. The partial differential evo-lution equations were lifted to the corresponding functional partial differential equations in functional space by introducing the time translation operator. The functional partial differential evolution equations were solved by algebraic dynam-ics. The algebraic dynamics solutions are analytical in Taylor series in terms of both initial functions and time. Based on the exact analytical solutions, a new nu-merical algorithm—algebraic dynamics algorithm was proposed for partial differ-ential evolution equations. The difficulty of and the way out for the algorithm were discussed. The application of the approach to and computer numerical experi-ments on the nonlinear Burgers equation and meteorological advection equation indicate that the algebraic dynamics approach and algebraic dynamics algorithm are effective to the solution of nonlinear partial differential evolution equations both analytically and numerically.

  20. Robust Algebraic Multilevel Methods and Algorithms

    CERN Document Server

    Kraus, Johannes

    2009-01-01

    This book deals with algorithms for the solution of linear systems of algebraic equations with large-scale sparse matrices, with a focus on problems that are obtained after discretization of partial differential equations using finite element methods. Provides a systematic presentation of the recent advances in robust algebraic multilevel methods. Can be used for advanced courses on the topic.

  1. A Multigrid Algorithm for an Elliptic Problem with a Perturbed Boundary Condition

    KAUST Repository

    Bonito, Andrea; Pasciak, Joseph E.

    2013-01-01

    We discuss the preconditioning of systems coupling elliptic operators in Ω⊂Rd, d=2,3, with elliptic operators defined on hypersurfaces. These systems arise naturally when physical phenomena are affected by geometric boundary forces, such as the evolution of liquid drops subject to surface tension. The resulting operators are sums of interior and boundary terms weighted by parameters. We investigate the behavior of multigrid algorithms suited to this context and demonstrate numerical results which suggest uniform preconditioning bounds that are level and parameter independent.

  2. Multigrid and multilevel domain decomposition for unstructured grids

    Energy Technology Data Exchange (ETDEWEB)

    Chan, T.; Smith, B.

    1994-12-31

    Multigrid has proven itself to be a very versatile method for the iterative solution of linear and nonlinear systems of equations arising from the discretization of PDES. In some applications, however, no natural multilevel structure of grids is available, and these must be generated as part of the solution procedure. In this presentation the authors will consider the problem of generating a multigrid algorithm when only a fine, unstructured grid is given. Their techniques generate a sequence of coarser grids by first forming an approximate maximal independent set of the vertices and then applying a Cavendish type algorithm to form the coarser triangulation. Numerical tests indicate that convergence using this approach can be as fast as standard multigrid on a structured mesh, at least in two dimensions.

  3. Multigrid

    CERN Document Server

    Trottenberg, Ulrich; Schuller, Anton

    2000-01-01

    Multigrid presents both an elementary introduction to multigrid methods for solving partial differential equations and a contemporary survey of advanced multigrid techniques and real-life applications.Multigrid methods are invaluable to researchers in scientific disciplines including physics, chemistry, meteorology, fluid and continuum mechanics, geology, biology, and all engineering disciplines. They are also becoming increasingly important in economics and financial mathematics.Readers are presented with an invaluable summary covering 25 years of practical experience acquired by the multigrid research group at the Germany National Research Center for Information Technology. The book presents both practical and theoretical points of view.* Covers the whole field of multigrid methods from its elements up to the most advanced applications* Style is essentially elementary but mathematically rigorous* No other book is so comprehensive and written for both practitioners and students

  4. 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

  5. Multigrid treatment of implicit continuum diffusion

    Science.gov (United States)

    Francisquez, Manaure; Zhu, Ben; Rogers, Barrett

    2017-10-01

    Implicit treatment of diffusive terms of various differential orders common in continuum mechanics modeling, such as computational fluid dynamics, is investigated with spectral and multigrid algorithms in non-periodic 2D domains. In doubly periodic time dependent problems these terms can be efficiently and implicitly handled by spectral methods, but in non-periodic systems solved with distributed memory parallel computing and 2D domain decomposition, this efficiency is lost for large numbers of processors. We built and present here a multigrid algorithm for these types of problems which outperforms a spectral solution that employs the highly optimized FFTW library. This multigrid algorithm is not only suitable for high performance computing but may also be able to efficiently treat implicit diffusion of arbitrary order by introducing auxiliary equations of lower order. We test these solvers for fourth and sixth order diffusion with idealized harmonic test functions as well as a turbulent 2D magnetohydrodynamic simulation. It is also shown that an anisotropic operator without cross-terms can improve model accuracy and speed, and we examine the impact that the various diffusion operators have on the energy, the enstrophy, and the qualitative aspect of a simulation. This work was supported by DOE-SC-0010508. This research used resources of the National Energy Research Scientific Computing Center (NERSC).

  6. Multigrid Methods for the Computation of Propagators in Gauge Fields

    Science.gov (United States)

    Kalkreuter, Thomas

    Multigrid methods were invented for the solution of discretized partial differential equations in order to overcome the slowness of traditional algorithms by updates on various length scales. In the present work generalizations of multigrid methods for propagators in gauge fields are investigated. Gauge fields are incorporated in algorithms in a covariant way. The kernel C of the restriction operator which averages from one grid to the next coarser grid is defined by projection on the ground-state of a local Hamiltonian. The idea behind this definition is that the appropriate notion of smoothness depends on the dynamics. The ground-state projection choice of C can be used in arbitrary dimension and for arbitrary gauge group. We discuss proper averaging operations for bosons and for staggered fermions. The kernels C can also be used in multigrid Monte Carlo simulations, and for the definition of block spins and blocked gauge fields in Monte Carlo renormalization group studies. Actual numerical computations are performed in four-dimensional SU(2) gauge fields. We prove that our proposals for block spins are “good”, using renormalization group arguments. A central result is that the multigrid method works in arbitrarily disordered gauge fields, in principle. It is proved that computations of propagators in gauge fields without critical slowing down are possible when one uses an ideal interpolation kernel. Unfortunately, the idealized algorithm is not practical, but it was important to answer questions of principle. Practical methods are able to outperform the conjugate gradient algorithm in case of bosons. The case of staggered fermions is harder. Multigrid methods give considerable speed-ups compared to conventional relaxation algorithms, but on lattices up to 184 conjugate gradient is superior.

  7. Parallel multigrid methods: implementation on message-passing computers and applications to fluid dynamics. A draft

    International Nuclear Information System (INIS)

    Solchenbach, K.; Thole, C.A.; Trottenberg, U.

    1987-01-01

    For a wide class of problems in scientific computing, in particular for partial differential equations, the multigrid principle has proved to yield highly efficient numerical methods. However, the principle has to be applied carefully: if the multigrid components are not chosen adequately with respect to the given problem, the efficiency may be much smaller than possible. This has been demonstrated for many practical problems. Unfortunately, the general theories on multigrid convergence do not give much help in constructing really efficient multigrid algorithms. Although some progress has been made in bridging the gap between theory and practice during the last few years, there are still several theoretical approaches which are misleading rather than helpful with respect to the objective of real efficiency. The research in finding highly efficient algorithms for non-model applications therefore is still a sophisticated mixture of theoretical considerations, a transfer of experiences from model to real life problems and systematical experimental work. The emphasis of the practical research activity today lies - among others - in the following fields: - finding efficient multigrid components for really complex problems, - combining the multigrid approach with advanced discretizative techniques: - constructing highly parallel multigrid algorithms. In this paper, we want to deal mainly with the last topic

  8. Parallel algorithms for numerical linear algebra

    CERN Document Server

    van der Vorst, H

    1990-01-01

    This is the first in a new series of books presenting research results and developments concerning the theory and applications of parallel computers, including vector, pipeline, array, fifth/future generation computers, and neural computers.All aspects of high-speed computing fall within the scope of the series, e.g. algorithm design, applications, software engineering, networking, taxonomy, models and architectural trends, performance, peripheral devices.Papers in Volume One cover the main streams of parallel linear algebra: systolic array algorithms, message-passing systems, algorithms for p

  9. A Pseudo-Temporal Multi-Grid Relaxation Scheme for Solving the Parabolized Navier-Stokes Equations

    Science.gov (United States)

    White, J. A.; Morrison, J. H.

    1999-01-01

    A multi-grid, flux-difference-split, finite-volume code, VULCAN, is presented for solving the elliptic and parabolized form of the equations governing three-dimensional, turbulent, calorically perfect and non-equilibrium chemically reacting flows. The space marching algorithms developed to improve convergence rate and or reduce computational cost are emphasized. The algorithms presented are extensions to the class of implicit pseudo-time iterative, upwind space-marching schemes. A full approximate storage, full multi-grid scheme is also described which is used to accelerate the convergence of a Gauss-Seidel relaxation method. The multi-grid algorithm is shown to significantly improve convergence on high aspect ratio grids.

  10. Multigrid for Staggered Lattice Fermions

    Energy Technology Data Exchange (ETDEWEB)

    Brower, Richard C. [Boston U.; Clark, M. A. [Unlisted, US; Strelchenko, Alexei [Fermilab; Weinberg, Evan [Boston U.

    2018-01-23

    Critical slowing down in Krylov methods for the Dirac operator presents a major obstacle to further advances in lattice field theory as it approaches the continuum solution. Here we formulate a multi-grid algorithm for the Kogut-Susskind (or staggered) fermion discretization which has proven difficult relative to Wilson multigrid due to its first-order anti-Hermitian structure. The solution is to introduce a novel spectral transformation by the K\\"ahler-Dirac spin structure prior to the Galerkin projection. We present numerical results for the two-dimensional, two-flavor Schwinger model, however, the general formalism is agnostic to dimension and is directly applicable to four-dimensional lattice QCD.

  11. An extended algebraic variational multiscale-multigrid-multifractal method (XAVM4) for large-eddy simulation of turbulent two-phase flow

    Science.gov (United States)

    Rasthofer, U.; Wall, W. A.; Gravemeier, V.

    2018-04-01

    A novel and comprehensive computational method, referred to as the eXtended Algebraic Variational Multiscale-Multigrid-Multifractal Method (XAVM4), is proposed for large-eddy simulation of the particularly challenging problem of turbulent two-phase flow. The XAVM4 involves multifractal subgrid-scale modeling as well as a Nitsche-type extended finite element method as an approach for two-phase flow. The application of an advanced structural subgrid-scale modeling approach in conjunction with a sharp representation of the discontinuities at the interface between two bulk fluids promise high-fidelity large-eddy simulation of turbulent two-phase flow. The high potential of the XAVM4 is demonstrated for large-eddy simulation of turbulent two-phase bubbly channel flow, that is, turbulent channel flow carrying a single large bubble of the size of the channel half-width in this particular application.

  12. Multigrid methods for the computation of propagators in gauge fields

    International Nuclear Information System (INIS)

    Kalkreuter, T.

    1992-11-01

    In the present work generalizations of multigrid methods for propagators in gauge fields are investigated. We discuss proper averaging operations for bosons and for staggered fermions. An efficient algorithm for computing C numerically is presented. The averaging kernels C can be used not only in deterministic multigrid computations, but also in multigrid Monte Carlo simulations, and for the definition of block spins and blocked gauge fields in Monte Carlo renormalization group studies of gauge theories. Actual numerical computations of kernels and propagators are performed in compact four-dimensional SU(2) gauge fields. (orig./HSI)

  13. Algebraic multigrid preconditioning within parallel finite-element solvers for 3-D electromagnetic modelling problems in geophysics

    Science.gov (United States)

    Koldan, Jelena; Puzyrev, Vladimir; de la Puente, Josep; Houzeaux, Guillaume; Cela, José María

    2014-06-01

    We present an elaborate preconditioning scheme for Krylov subspace methods which has been developed to improve the performance and reduce the execution time of parallel node-based finite-element (FE) solvers for 3-D electromagnetic (EM) numerical modelling in exploration geophysics. This new preconditioner is based on algebraic multigrid (AMG) that uses different basic relaxation methods, such as Jacobi, symmetric successive over-relaxation (SSOR) and Gauss-Seidel, as smoothers and the wave front algorithm to create groups, which are used for a coarse-level generation. We have implemented and tested this new preconditioner within our parallel nodal FE solver for 3-D forward problems in EM induction geophysics. We have performed series of experiments for several models with different conductivity structures and characteristics to test the performance of our AMG preconditioning technique when combined with biconjugate gradient stabilized method. The results have shown that, the more challenging the problem is in terms of conductivity contrasts, ratio between the sizes of grid elements and/or frequency, the more benefit is obtained by using this preconditioner. Compared to other preconditioning schemes, such as diagonal, SSOR and truncated approximate inverse, the AMG preconditioner greatly improves the convergence of the iterative solver for all tested models. Also, when it comes to cases in which other preconditioners succeed to converge to a desired precision, AMG is able to considerably reduce the total execution time of the forward-problem code-up to an order of magnitude. Furthermore, the tests have confirmed that our AMG scheme ensures grid-independent rate of convergence, as well as improvement in convergence regardless of how big local mesh refinements are. In addition, AMG is designed to be a black-box preconditioner, which makes it easy to use and combine with different iterative methods. Finally, it has proved to be very practical and efficient in the

  14. Finite volume multigrid method of the planar contraction flow of a viscoelastic fluid

    Science.gov (United States)

    Moatssime, H. Al; Esselaoui, D.; Hakim, A.; Raghay, S.

    2001-08-01

    This paper reports on a numerical algorithm for the steady flow of viscoelastic fluid. The conservative and constitutive equations are solved using the finite volume method (FVM) with a hybrid scheme for the velocities and first-order upwind approximation for the viscoelastic stress. A non-uniform staggered grid system is used. The iterative SIMPLE algorithm is employed to relax the coupled momentum and continuity equations. The non-linear algebraic equations over the flow domain are solved iteratively by the symmetrical coupled Gauss-Seidel (SCGS) method. In both, the full approximation storage (FAS) multigrid algorithm is used. An Oldroyd-B fluid model was selected for the calculation. Results are reported for planar 4:1 abrupt contraction at various Weissenberg numbers. The solutions are found to be stable and smooth. The solutions show that at high Weissenberg number the domain must be long enough. The convergence of the method has been verified with grid refinement. All the calculations have been performed on a PC equipped with a Pentium III processor at 550 MHz. Copyright

  15. Ground-state projection multigrid for propagators in 4-dimensional SU(2) gauge fields

    International Nuclear Information System (INIS)

    Kalkreuter, T.

    1991-09-01

    The ground-state projection multigrid method is studied for computations of slowly decaying bosonic propagators in 4-dimensional SU(2) lattice gauge theory. The defining eigenvalue equation for the restriction operator is solved exactly. Although the critical exponent z is not reduced in nontrivial gauge fields, multigrid still yields considerable speedup compared with conventional relaxation. Multigrid is also able to outperform the conjugate gradient algorithm. (orig.)

  16. Performance Analysis of a Decoding Algorithm for Algebraic Geometry Codes

    DEFF Research Database (Denmark)

    Jensen, Helge Elbrønd; Nielsen, Rasmus Refslund; Høholdt, Tom

    1998-01-01

    We analyse the known decoding algorithms for algebraic geometry codes in the case where the number of errors is greater than or equal to [(dFR-1)/2]+1, where dFR is the Feng-Rao distance......We analyse the known decoding algorithms for algebraic geometry codes in the case where the number of errors is greater than or equal to [(dFR-1)/2]+1, where dFR is the Feng-Rao distance...

  17. Analysis and development of stochastic multigrid methods in lattice field theory

    International Nuclear Information System (INIS)

    Grabenstein, M.

    1994-01-01

    We study the relation between the dynamical critical behavior and the kinematics of stochastic multigrid algorithms. The scale dependence of acceptance rates for nonlocal Metropolis updates is analyzed with the help of an approximation formula. A quantitative study of the kinematics of multigrid algorithms in several interacting models is performed. We find that for a critical model with Hamiltonian H(Φ) absence of critical slowing down can only be expected if the expansion of (H(Φ+ψ)) in terms of the shift ψ contains no relevant term (mass term). The predictions of this rule was verified in a multigrid Monte Carlo simulation of the Sine Gordon model in two dimensions. Our analysis can serve as a guideline for the development of new algorithms: We propose a new multigrid method for nonabelian lattice gauge theory, the time slice blocking. For SU(2) gauge fields in two dimensions, critical slowing down is almost completely eliminated by this method, in accordance with the theoretical prediction. The generalization of the time slice blocking to SU(2) in four dimensions is investigated analytically and by numerical simulations. Compared to two dimensions, the local disorder in the four dimensional gauge field leads to kinematical problems. (orig.)

  18. Algorithmic and experimental methods in algebra, geometry, and number theory

    CERN Document Server

    Decker, Wolfram; Malle, Gunter

    2017-01-01

    This book presents state-of-the-art research and survey articles that highlight work done within the Priority Program SPP 1489 “Algorithmic and Experimental Methods in Algebra, Geometry and Number Theory”, which was established and generously supported by the German Research Foundation (DFG) from 2010 to 2016. The goal of the program was to substantially advance algorithmic and experimental methods in the aforementioned disciplines, to combine the different methods where necessary, and to apply them to central questions in theory and practice. Of particular concern was the further development of freely available open source computer algebra systems and their interaction in order to create powerful new computational tools that transcend the boundaries of the individual disciplines involved.  The book covers a broad range of topics addressing the design and theoretical foundations, implementation and the successful application of algebraic algorithms in order to solve mathematical research problems. It off...

  19. An algorithm for analysis of the structure of finitely presented Lie algebras

    Directory of Open Access Journals (Sweden)

    Vladimir P. Gerdt

    1997-12-01

    Full Text Available We consider the following problem: what is the most general Lie algebra satisfying a given set of Lie polynomial equations? The presentation of Lie algebras by a finite set of generators and defining relations is one of the most general mathematical and algorithmic schemes of their analysis. That problem is of great practical importance, covering applications ranging from mathematical physics to combinatorial algebra. Some particular applications are constructionof prolongation algebras in the Wahlquist-Estabrook method for integrability analysis of nonlinear partial differential equations and investigation of Lie algebras arising in different physical models. The finite presentations also indicate a way to q-quantize Lie algebras. To solve this problem, one should perform a large volume of algebraic transformations which is sharply increased with growth of the number of generators and relations. For this reason, in practice one needs to use a computer algebra tool. We describe here an algorithm for constructing the basis of a finitely presented Lie algebra and its commutator table, and its implementation in the C language. Some computer results illustrating our algorithmand its actual implementation are also presented.

  20. Parallel multigrid smoothing: polynomial versus Gauss-Seidel

    International Nuclear Information System (INIS)

    Adams, Mark; Brezina, Marian; Hu, Jonathan; Tuminaro, Ray

    2003-01-01

    Gauss-Seidel is often the smoother of choice within multigrid applications. In the context of unstructured meshes, however, maintaining good parallel efficiency is difficult with multiplicative iterative methods such as Gauss-Seidel. This leads us to consider alternative smoothers. We discuss the computational advantages of polynomial smoothers within parallel multigrid algorithms for positive definite symmetric systems. Two particular polynomials are considered: Chebyshev and a multilevel specific polynomial. The advantages of polynomial smoothing over traditional smoothers such as Gauss-Seidel are illustrated on several applications: Poisson's equation, thin-body elasticity, and eddy current approximations to Maxwell's equations. While parallelizing the Gauss-Seidel method typically involves a compromise between a scalable convergence rate and maintaining high flop rates, polynomial smoothers achieve parallel scalable multigrid convergence rates without sacrificing flop rates. We show that, although parallel computers are the main motivation, polynomial smoothers are often surprisingly competitive with Gauss-Seidel smoothers on serial machines

  1. Parallel multigrid smoothing: polynomial versus Gauss-Seidel

    Science.gov (United States)

    Adams, Mark; Brezina, Marian; Hu, Jonathan; Tuminaro, Ray

    2003-07-01

    Gauss-Seidel is often the smoother of choice within multigrid applications. In the context of unstructured meshes, however, maintaining good parallel efficiency is difficult with multiplicative iterative methods such as Gauss-Seidel. This leads us to consider alternative smoothers. We discuss the computational advantages of polynomial smoothers within parallel multigrid algorithms for positive definite symmetric systems. Two particular polynomials are considered: Chebyshev and a multilevel specific polynomial. The advantages of polynomial smoothing over traditional smoothers such as Gauss-Seidel are illustrated on several applications: Poisson's equation, thin-body elasticity, and eddy current approximations to Maxwell's equations. While parallelizing the Gauss-Seidel method typically involves a compromise between a scalable convergence rate and maintaining high flop rates, polynomial smoothers achieve parallel scalable multigrid convergence rates without sacrificing flop rates. We show that, although parallel computers are the main motivation, polynomial smoothers are often surprisingly competitive with Gauss-Seidel smoothers on serial machines.

  2. Multigrid Computation of Stratified Flow over Two-Dimensional Obstacles

    Science.gov (United States)

    Paisley, M. F.

    1997-09-01

    A robust multigrid method for the incompressible Navier-Stokes equations is presented and applied to the computation of viscous flow over obstacles in a bounded domain under conditions of neutral stability and stable density stratification. Two obstacle shapes have been used, namely a vertical barrier, for which the grid is Cartesian, and a smooth cosine-shaped obstacle, for which a boundary-conforming transformation is incorporated. Results are given for laminar flows at low Reynolds numbers and turbulent flows at a high Reynolds number, when a simple mixing length turbulence model is included. The multigrid algorithm is used to compute steady flows for each obstacle at low and high Reynolds numbers in conditions of weak static stability, defined byK=ND/πU≤ 1, whereU,N, andDare the upstream velocity, bouyancy frequency, and domain height respectively. Results are also presented for the vertical barrier at low and high Reynolds number in conditions of strong static stability,K> 1, when lee wave motions ensure that the flow is unsteady, and the multigrid algorithm is used to compute the flow at each timestep.

  3. Efficient relaxed-Jacobi smoothers for multigrid on parallel computers

    Science.gov (United States)

    Yang, Xiang; Mittal, Rajat

    2017-03-01

    In this Technical Note, we present a family of Jacobi-based multigrid smoothers suitable for the solution of discretized elliptic equations. These smoothers are based on the idea of scheduled-relaxation Jacobi proposed recently by Yang & Mittal (2014) [18] and employ two or three successive relaxed Jacobi iterations with relaxation factors derived so as to maximize the smoothing property of these iterations. The performance of these new smoothers measured in terms of convergence acceleration and computational workload, is assessed for multi-domain implementations typical of parallelized solvers, and compared to the lexicographic point Gauss-Seidel smoother. The tests include the geometric multigrid method on structured grids as well as the algebraic grid method on unstructured grids. The tests demonstrate that unlike Gauss-Seidel, the convergence of these Jacobi-based smoothers is unaffected by domain decomposition, and furthermore, they outperform the lexicographic Gauss-Seidel by factors that increase with domain partition count.

  4. Multigrid methods III

    CERN Document Server

    Trottenberg, U; Third European Conference on Multigrid Methods

    1991-01-01

    These proceedings contain a selection of papers presented at the Third European Conference on Multigrid Methods which was held in Bonn on October 1-4, 1990. Following conferences in 1981 and 1985, a platform for the presentation of new Multigrid results was provided for a third time. Multigrid methods no longer have problems being accepted by numerical analysts and users of numerical methods; on the contrary, they have been further developed in such a successful way that they have penetrated a variety of new fields of application. The high number of 154 participants from 18 countries and 76 presented papers show the need to continue the series of the European Multigrid Conferences. The papers of this volume give a survey on the current Multigrid situation; in particular, they correspond to those fields where new developments can be observed. For example, se­ veral papers study the appropriate treatment of time dependent problems. Improvements can also be noticed in the Multigrid approach for semiconductor eq...

  5. Aplicação do pré-condicionador Multigrid Algébrico baseado em Wavelet no cálculo de campos magnéticos não lineares

    Directory of Open Access Journals (Sweden)

    Fabio Henrique Pereira

    2009-01-01

    Full Text Available In this work the performance of ¿-cycle wavelet-based algebraic multigrid preconditioner for iterative methods is investigated. The method is applied as a preconditioner for the classical iterative methods Bi-Conjugate Gradient Stabilized (BiCGStab, Generalized Minimum Residual (GMRes and Conjugate Gradient (CG to the solution of non-linear system of algebraic equations from the analysis of a switched reluctance motor with ferromagnetic material the steel S45C and nonlinear magnetization curve, associated with the Newton-Raphson algorithm. Particular attention has been focused in both V- and W-cycle convergence factors, as well as the CPU time. Numerical results show the efficiency of the proposed techniques when compared with classical preconditioner, such as Incomplete Cholesky and Incomplete LU decomposition.

  6. Nonlinear Multigrid solver exploiting AMGe Coarse Spaces with Approximation Properties

    DEFF Research Database (Denmark)

    Christensen, Max la Cour; Villa, Umberto; Engsig-Karup, Allan Peter

    The paper introduces a nonlinear multigrid solver for mixed finite element discretizations based on the Full Approximation Scheme (FAS) and element-based Algebraic Multigrid (AMGe). The main motivation to use FAS for unstructured problems is the guaranteed approximation property of the AMGe coarse...... properties of the coarse spaces. With coarse spaces with approximation properties, our FAS approach on unstructured meshes has the ability to be as powerful/successful as FAS on geometrically refined meshes. For comparison, Newton’s method and Picard iterations with an inner state-of-the-art linear solver...... are compared to FAS on a nonlinear saddle point problem with applications to porous media flow. It is demonstrated that FAS is faster than Newton’s method and Picard iterations for the experiments considered here. Due to the guaranteed approximation properties of our AMGe, the coarse spaces are very accurate...

  7. Asynchronous Task-Based Parallelization of Algebraic Multigrid

    KAUST Repository

    AlOnazi, Amani A.; Markomanolis, George S.; Keyes, David E.

    2017-01-01

    As processor clock rates become more dynamic and workloads become more adaptive, the vulnerability to global synchronization that already complicates programming for performance in today's petascale environment will be exacerbated. Algebraic

  8. An Algorithm for Isolating the Real Solutions of Piecewise Algebraic Curves

    Directory of Open Access Journals (Sweden)

    Jinming Wu

    2011-01-01

    to compute the real solutions of two piecewise algebraic curves. It is primarily based on the Krawczyk-Moore iterative algorithm and good initial iterative interval searching algorithm. The proposed algorithm is relatively easy to implement.

  9. Copper Mountain conference on multigrid methods. Preliminary proceedings -- List of abstracts

    Energy Technology Data Exchange (ETDEWEB)

    NONE

    1995-12-31

    This report contains abstracts of the papers presented at the conference. Papers cover multigrid algorithms and applications of multigrid methods. Applications include the following: solution of elliptical problems; electric power grids; fluid mechanics; atmospheric data assimilation; thermocapillary effects on weld pool shape; boundary-value problems; prediction of hurricane tracks; modeling multi-dimensional combustion and detailed chemistry; black-oil reservoir simulation; image processing; and others.

  10. Algorithmic algebraic geometry and flux vacua

    International Nuclear Information System (INIS)

    Gray, James; He Yanghui; Lukas, Andre

    2006-01-01

    We develop a new and efficient method to systematically analyse four dimensional effective supergravities which descend from flux compactifications. The issue of finding vacua of such systems, both supersymmetric and non-supersymmetric, is mapped into a problem in computational algebraic geometry. Using recent developments in computer algebra, the problem can then be rapidly dealt with in a completely algorithmic fashion. Two main results are (1) a procedure for calculating constraints which the flux parameters must satisfy in these models if any given type of vacuum is to exist; (2) a stepwise process for finding all of the isolated vacua of such systems and their physical properties. We illustrate our discussion with several concrete examples, some of which have eluded conventional methods so far

  11. Multicloud: Multigrid convergence with a meshless operator

    International Nuclear Information System (INIS)

    Katz, Aaron; Jameson, Antony

    2009-01-01

    The primary objective of this work is to develop and test a new convergence acceleration technique we call multicloud. Multicloud is well-founded in the mathematical basis of multigrid, but relies on a meshless operator on coarse levels. The meshless operator enables extremely simple and automatic coarsening procedures for arbitrary meshes using arbitrary fine level discretization schemes. The performance of multicloud is compared with established multigrid techniques for structured and unstructured meshes for the Euler equations on two-dimensional test cases. Results indicate comparable convergence rates per unit work for multicloud and multigrid. However, because of its mesh and scheme transparency, multicloud may be applied to a wide array of problems with no modification of fine level schemes as is often required with agglomeration techniques. The implication is that multicloud can be implemented in a completely modular fashion, allowing researchers to develop fine level algorithms independent of the convergence accelerator for complex three-dimensional problems.

  12. Achieving Textbook Multigrid Efficiency for Hydrostatic Ice Sheet Flow

    KAUST Repository

    Brown, Jed; Smith, Barry; Ahmadia, Aron

    2013-01-01

    The hydrostatic equations for ice sheet flow offer improved fidelity compared with the shallow ice approximation and shallow stream approximation popular in today's ice sheet models. Nevertheless, they present a serious bottleneck because they require the solution of a three-dimensional (3D) nonlinear system, as opposed to the two-dimensional system present in the shallow stream approximation. This 3D system is posed on high-aspect domains with strong anisotropy and variation in coefficients, making it expensive to solve with current methods. This paper presents a Newton--Krylov multigrid solver for the hydrostatic equations that demonstrates textbook multigrid efficiency (an order of magnitude reduction in residual per iteration and solution of the fine-level system at a small multiple of the cost of a residual evaluation). Scalability on Blue Gene/P is demonstrated, and the method is compared to various algebraic methods that are in use or have been proposed as viable approaches.

  13. Achieving Textbook Multigrid Efficiency for Hydrostatic Ice Sheet Flow

    KAUST Repository

    Brown, Jed

    2013-03-12

    The hydrostatic equations for ice sheet flow offer improved fidelity compared with the shallow ice approximation and shallow stream approximation popular in today\\'s ice sheet models. Nevertheless, they present a serious bottleneck because they require the solution of a three-dimensional (3D) nonlinear system, as opposed to the two-dimensional system present in the shallow stream approximation. This 3D system is posed on high-aspect domains with strong anisotropy and variation in coefficients, making it expensive to solve with current methods. This paper presents a Newton--Krylov multigrid solver for the hydrostatic equations that demonstrates textbook multigrid efficiency (an order of magnitude reduction in residual per iteration and solution of the fine-level system at a small multiple of the cost of a residual evaluation). Scalability on Blue Gene/P is demonstrated, and the method is compared to various algebraic methods that are in use or have been proposed as viable approaches.

  14. Numerical Methods for Forward and Inverse Problems in Discontinuous Media

    Energy Technology Data Exchange (ETDEWEB)

    Chartier, Timothy P.

    2011-03-08

    The research emphasis under this grant's funding is in the area of algebraic multigrid methods. The research has two main branches: 1) exploring interdisciplinary applications in which algebraic multigrid can make an impact and 2) extending the scope of algebraic multigrid methods with algorithmic improvements that are based in strong analysis.The work in interdisciplinary applications falls primarily in the field of biomedical imaging. Work under this grant demonstrated the effectiveness and robustness of multigrid for solving linear systems that result from highly heterogeneous finite element method models of the human head. The results in this work also give promise to medical advances possible with software that may be developed. Research to extend the scope of algebraic multigrid has been focused in several areas. In collaboration with researchers at the University of Colorado, Lawrence Livermore National Laboratory, and Los Alamos National Laboratory, the PI developed an adaptive multigrid with subcycling via complementary grids. This method has very cheap computing costs per iterate and is showing promise as a preconditioner for conjugate gradient. Recent work with Los Alamos National Laboratory concentrates on developing algorithms that take advantage of the recent advances in adaptive multigrid research. The results of the various efforts in this research could ultimately have direct use and impact to researchers for a wide variety of applications, including, astrophysics, neuroscience, contaminant transport in porous media, bi-domain heart modeling, modeling of tumor growth, and flow in heterogeneous porous media. This work has already led to basic advances in computational mathematics and numerical linear algebra and will continue to do so into the future.

  15. An implicit multigrid algorithm for computing hypersonic, chemically reacting viscous flows

    International Nuclear Information System (INIS)

    Edwards, J.R.

    1996-01-01

    An implicit algorithm for computing viscous flows in chemical nonequilibrium is presented. Emphasis is placed on the numerical efficiency of the time integration scheme, both in terms of periteration workload and overall convergence rate. In this context, several techniques are introduced, including a stable, O(m 2 ) approximate factorization of the chemical source Jacobian and implementations of V-cycle and filtered multigrid acceleration methods. A five species-seventeen reaction air model is used to calculate hypersonic viscous flow over a cylinder at conditions corresponding to flight at 5 km/s, 60 km altitude and at 11.36 km/s, 76.42 km altitude. Inviscid calculations using an eleven-species reaction mechanism including ionization are presented for a case involving 11.37 km/s flow at an altitude of 84.6 km. Comparisons among various options for the implicit treatment of the chemical source terms and among different multilevel approaches for convergence acceleration are presented for all simulations

  16. Block-accelerated aggregation multigrid for Markov chains with application to PageRank problems

    Science.gov (United States)

    Shen, Zhao-Li; Huang, Ting-Zhu; Carpentieri, Bruno; Wen, Chun; Gu, Xian-Ming

    2018-06-01

    Recently, the adaptive algebraic aggregation multigrid method has been proposed for computing stationary distributions of Markov chains. This method updates aggregates on every iterative cycle to keep high accuracies of coarse-level corrections. Accordingly, its fast convergence rate is well guaranteed, but often a large proportion of time is cost by aggregation processes. In this paper, we show that the aggregates on each level in this method can be utilized to transfer the probability equation of that level into a block linear system. Then we propose a Block-Jacobi relaxation that deals with the block system on each level to smooth error. Some theoretical analysis of this technique is presented, meanwhile it is also adapted to solve PageRank problems. The purpose of this technique is to accelerate the adaptive aggregation multigrid method and its variants for solving Markov chains and PageRank problems. It also attempts to shed some light on new solutions for making aggregation processes more cost-effective for aggregation multigrid methods. Numerical experiments are presented to illustrate the effectiveness of this technique.

  17. Performance analysis of a decoding algorithm for algebraic-geometry codes

    DEFF Research Database (Denmark)

    Høholdt, Tom; Jensen, Helge Elbrønd; Nielsen, Rasmus Refslund

    1999-01-01

    The fast decoding algorithm for one point algebraic-geometry codes of Sakata, Elbrond Jensen, and Hoholdt corrects all error patterns of weight less than half the Feng-Rao minimum distance. In this correspondence we analyze the performance of the algorithm for heavier error patterns. It turns out...

  18. Searching dependency between algebraic equations: An algorithm applied to automated reasoning

    International Nuclear Information System (INIS)

    Yang Lu; Zhang Jingzhong

    1990-01-01

    An efficient computer algorithm is given to decide how many branches of the solution to a system of algebraic also solve another equation. As one of the applications, this can be used in practice to verify a conjecture with hypotheses and conclusion expressed by algebraic equations, despite the variety of reducible or irreducible. (author). 10 refs

  19. Uniform convergence of multigrid V-cycle iterations for indefinite and nonsymmetric problems

    Science.gov (United States)

    Bramble, James H.; Kwak, Do Y.; Pasciak, Joseph E.

    1993-01-01

    In this paper, we present an analysis of a multigrid method for nonsymmetric and/or indefinite elliptic problems. In this multigrid method various types of smoothers may be used. One type of smoother which we consider is defined in terms of an associated symmetric problem and includes point and line, Jacobi, and Gauss-Seidel iterations. We also study smoothers based entirely on the original operator. One is based on the normal form, that is, the product of the operator and its transpose. Other smoothers studied include point and line, Jacobi, and Gauss-Seidel. We show that the uniform estimates for symmetric positive definite problems carry over to these algorithms. More precisely, the multigrid iteration for the nonsymmetric and/or indefinite problem is shown to converge at a uniform rate provided that the coarsest grid in the multilevel iteration is sufficiently fine (but not depending on the number of multigrid levels).

  20. MultiAspect Graphs: Algebraic Representation and Algorithms

    Directory of Open Access Journals (Sweden)

    Klaus Wehmuth

    2016-12-01

    Full Text Available We present the algebraic representation and basic algorithms for MultiAspect Graphs (MAGs. A MAG is a structure capable of representing multilayer and time-varying networks, as well as higher-order networks, while also having the property of being isomorphic to a directed graph. In particular, we show that, as a consequence of the properties associated with the MAG structure, a MAG can be represented in matrix form. Moreover, we also show that any possible MAG function (algorithm can be obtained from this matrix-based representation. This is an important theoretical result since it paves the way for adapting well-known graph algorithms for application in MAGs. We present a set of basic MAG algorithms, constructed from well-known graph algorithms, such as degree computing, Breadth First Search (BFS, and Depth First Search (DFS. These algorithms adapted to the MAG context can be used as primitives for building other more sophisticated MAG algorithms. Therefore, such examples can be seen as guidelines on how to properly derive MAG algorithms from basic algorithms on directed graphs. We also make available Python implementations of all the algorithms presented in this paper.

  1. Algorithmic Algebraic Combinatorics and Gröbner Bases

    CERN Document Server

    Klin, Mikhail; Jurisic, Aleksandar

    2009-01-01

    This collection of tutorial and research papers introduces readers to diverse areas of modern pure and applied algebraic combinatorics and finite geometries with a special emphasis on algorithmic aspects and the use of the theory of Grobner bases. Topics covered include coherent configurations, association schemes, permutation groups, Latin squares, the Jacobian conjecture, mathematical chemistry, extremal combinatorics, coding theory, designs, etc. Special attention is paid to the description of innovative practical algorithms and their implementation in software packages such as GAP and MAGM

  2. Realization of preconditioned Lanczos and conjugate gradient algorithms on optical linear algebra processors.

    Science.gov (United States)

    Ghosh, A

    1988-08-01

    Lanczos and conjugate gradient algorithms are important in computational linear algebra. In this paper, a parallel pipelined realization of these algorithms on a ring of optical linear algebra processors is described. The flow of data is designed to minimize the idle times of the optical multiprocessor and the redundancy of computations. The effects of optical round-off errors on the solutions obtained by the optical Lanczos and conjugate gradient algorithms are analyzed, and it is shown that optical preconditioning can improve the accuracy of these algorithms substantially. Algorithms for optical preconditioning and results of numerical experiments on solving linear systems of equations arising from partial differential equations are discussed. Since the Lanczos algorithm is used mostly with sparse matrices, a folded storage scheme to represent sparse matrices on spatial light modulators is also described.

  3. MAPCUMBA: A fast iterative multi-grid map-making algorithm for CMB experiments

    Science.gov (United States)

    Doré, O.; Teyssier, R.; Bouchet, F. R.; Vibert, D.; Prunet, S.

    2001-07-01

    The data analysis of current Cosmic Microwave Background (CMB) experiments like BOOMERanG or MAXIMA poses severe challenges which already stretch the limits of current (super-) computer capabilities, if brute force methods are used. In this paper we present a practical solution for the optimal map making problem which can be used directly for next generation CMB experiments like ARCHEOPS and TopHat, and can probably be extended relatively easily to the full PLANCK case. This solution is based on an iterative multi-grid Jacobi algorithm which is both fast and memory sparing. Indeed, if there are Ntod data points along the one dimensional timeline to analyse, the number of operations is of O (Ntod \\ln Ntod) and the memory requirement is O (Ntod). Timing and accuracy issues have been analysed on simulated ARCHEOPS and TopHat data, and we discuss as well the issue of the joint evaluation of the signal and noise statistical properties.

  4. Improved Solver Settings for 3D Exploding Wire Simulations in ALEGRA

    Science.gov (United States)

    2016-08-01

    performance and rate of throughput of ALEGRA-MHD simulations. The algebraic multigrid algorithms in ML approximate the solution of a linear sys- tem on a fine...in the algebraic multigrid preconditioner, Trilinos/ML, as implemented in ALEGRA. Three parameters impacted performance with one dominating. We provide...option (RM << 1) is not quite applicable and not used in this study. ALEGRA uses explicit time integration to solve the solid-dynamic and nonresistive

  5. On a multigrid method for the coupled Stokes and porous media flow problem

    Science.gov (United States)

    Luo, P.; Rodrigo, C.; Gaspar, F. J.; Oosterlee, C. W.

    2017-07-01

    The multigrid solution of coupled porous media and Stokes flow problems is considered. The Darcy equation as the saturated porous medium model is coupled to the Stokes equations by means of appropriate interface conditions. We focus on an efficient multigrid solution technique for the coupled problem, which is discretized by finite volumes on staggered grids, giving rise to a saddle point linear system. Special treatment is required regarding the discretization at the interface. An Uzawa smoother is employed in multigrid, which is a decoupled procedure based on symmetric Gauss-Seidel smoothing for velocity components and a simple Richardson iteration for the pressure field. Since a relaxation parameter is part of a Richardson iteration, Local Fourier Analysis (LFA) is applied to determine the optimal parameters. Highly satisfactory multigrid convergence is reported, and, moreover, the algorithm performs well for small values of the hydraulic conductivity and fluid viscosity, that are relevant for applications.

  6. Multigrid on unstructured grids using an auxiliary set of structured grids

    Energy Technology Data Exchange (ETDEWEB)

    Douglas, C.C.; Malhotra, S.; Schultz, M.H. [Yale Univ., New Haven, CT (United States)

    1996-12-31

    Unstructured grids do not have a convenient and natural multigrid framework for actually computing and maintaining a high floating point rate on standard computers. In fact, just the coarsening process is expensive for many applications. Since unstructured grids play a vital role in many scientific computing applications, many modifications have been proposed to solve this problem. One suggested solution is to map the original unstructured grid onto a structured grid. This can be used as a fine grid in a standard multigrid algorithm to precondition the original problem on the unstructured grid. We show that unless extreme care is taken, this mapping can lead to a system with a high condition number which eliminates the usefulness of the multigrid method. Theorems with lower and upper bounds are provided. Simple examples show that the upper bounds are sharp.

  7. An Improved Algorithm for Generating Database Transactions from Relational Algebra Specifications

    Directory of Open Access Journals (Sweden)

    Daniel J. Dougherty

    2010-03-01

    Full Text Available Alloy is a lightweight modeling formalism based on relational algebra. In prior work with Fisler, Giannakopoulos, Krishnamurthi, and Yoo, we have presented a tool, Alchemy, that compiles Alloy specifications into implementations that execute against persistent databases. The foundation of Alchemy is an algorithm for rewriting relational algebra formulas into code for database transactions. In this paper we report on recent progress in improving the robustness and efficiency of this transformation.

  8. Thirty-three miniatures mathematical and algorithmic applications of linear algebra

    CERN Document Server

    Matousek, Jiří

    2010-01-01

    This volume contains a collection of clever mathematical applications of linear algebra, mainly in combinatorics, geometry, and algorithms. Each chapter covers a single main result with motivation and full proof in at most ten pages and can be read independently of all other chapters (with minor exceptions), assuming only a modest background in linear algebra. The topics include a number of well-known mathematical gems, such as Hamming codes, the matrix-tree theorem, the Lov�sz bound on the Shannon capacity, and a counterexample to Borsuk's conjecture, as well as other, perhaps less popular but similarly beautiful results, e.g., fast associativity testing, a lemma of Steinitz on ordering vectors, a monotonicity result for integer partitions, or a bound for set pairs via exterior products. The simpler results in the first part of the book provide ample material to liven up an undergraduate course of linear algebra. The more advanced parts can be used for a graduate course of linear-algebraic methods or for s...

  9. Additional operations in algebra of structural numbers for control algorithm development

    Directory of Open Access Journals (Sweden)

    Morhun A.V.

    2016-12-01

    Full Text Available The structural numbers and the algebra of the structural numbers due to the simplicity of representation, flexibility and current algebraic operations are the powerful tool for a wide range of applications. In autonomous power supply systems and systems with distributed generation (Micro Grid mathematical apparatus of structural numbers can be effectively used for the calculation of the parameters of the operating modes of consumption of electric energy. The purpose of the article is the representation of the additional algebra of structural numbers. The standard algebra was proposed to be extended by the additional operations and modification current in order to expand the scope of their use, namely to construct a flexible, adaptive algorithms of control systems. It is achieved due to the possibility to consider each individual component of the system with its parameters and provide easy management of entire system and each individual component. Thus, structural numbers and extended algebra are the perspective line of research and further studying is required.

  10. The multigrid preconditioned conjugate gradient method

    Science.gov (United States)

    Tatebe, Osamu

    1993-01-01

    A multigrid preconditioned conjugate gradient method (MGCG method), which uses the multigrid method as a preconditioner of the PCG method, is proposed. The multigrid method has inherent high parallelism and improves convergence of long wavelength components, which is important in iterative methods. By using this method as a preconditioner of the PCG method, an efficient method with high parallelism and fast convergence is obtained. First, it is considered a necessary condition of the multigrid preconditioner in order to satisfy requirements of a preconditioner of the PCG method. Next numerical experiments show a behavior of the MGCG method and that the MGCG method is superior to both the ICCG method and the multigrid method in point of fast convergence and high parallelism. This fast convergence is understood in terms of the eigenvalue analysis of the preconditioned matrix. From this observation of the multigrid preconditioner, it is realized that the MGCG method converges in very few iterations and the multigrid preconditioner is a desirable preconditioner of the conjugate gradient method.

  11. Conjugate gradient coupled with multigrid for an indefinite problem

    Science.gov (United States)

    Gozani, J.; Nachshon, A.; Turkel, E.

    1984-01-01

    An iterative algorithm for the Helmholtz equation is presented. This scheme was based on the preconditioned conjugate gradient method for the normal equations. The preconditioning is one cycle of a multigrid method for the discrete Laplacian. The smoothing algorithm is red-black Gauss-Seidel and is constructed so it is a symmetric operator. The total number of iterations needed by the algorithm is independent of h. By varying the number of grids, the number of iterations depends only weakly on k when k(3)h(2) is constant. Comparisons with a SSOR preconditioner are presented.

  12. Design and Implementation of Numerical Linear Algebra Algorithms on Fixed Point DSPs

    Directory of Open Access Journals (Sweden)

    Gene Frantz

    2007-01-01

    Full Text Available Numerical linear algebra algorithms use the inherent elegance of matrix formulations and are usually implemented using C/C++ floating point representation. The system implementation is faced with practical constraints because these algorithms usually need to run in real time on fixed point digital signal processors (DSPs to reduce total hardware costs. Converting the simulation model to fixed point arithmetic and then porting it to a target DSP device is a difficult and time-consuming process. In this paper, we analyze the conversion process. We transformed selected linear algebra algorithms from floating point to fixed point arithmetic, and compared real-time requirements and performance between the fixed point DSP and floating point DSP algorithm implementations. We also introduce an advanced code optimization and an implementation by DSP-specific, fixed point C code generation. By using the techniques described in the paper, speed can be increased by a factor of up to 10 compared to floating point emulation on fixed point hardware.

  13. ALGEBRA: ALgorithm for the heterogeneous dosimetry based on GEANT4 for BRAchytherapy.

    Science.gov (United States)

    Afsharpour, H; Landry, G; D'Amours, M; Enger, S; Reniers, B; Poon, E; Carrier, J-F; Verhaegen, F; Beaulieu, L

    2012-06-07

    Task group 43 (TG43)-based dosimetry algorithms are efficient for brachytherapy dose calculation in water. However, human tissues have chemical compositions and densities different than water. Moreover, the mutual shielding effect of seeds on each other (interseed attenuation) is neglected in the TG43-based dosimetry platforms. The scientific community has expressed the need for an accurate dosimetry platform in brachytherapy. The purpose of this paper is to present ALGEBRA, a Monte Carlo platform for dosimetry in brachytherapy which is sufficiently fast and accurate for clinical and research purposes. ALGEBRA is based on the GEANT4 Monte Carlo code and is capable of handling the DICOM RT standard to recreate a virtual model of the treated site. Here, the performance of ALGEBRA is presented for the special case of LDR brachytherapy in permanent prostate and breast seed implants. However, the algorithm is also capable of handling other treatments such as HDR brachytherapy.

  14. Acoustooptic linear algebra processors - Architectures, algorithms, and applications

    Science.gov (United States)

    Casasent, D.

    1984-01-01

    Architectures, algorithms, and applications for systolic processors are described with attention to the realization of parallel algorithms on various optical systolic array processors. Systolic processors for matrices with special structure and matrices of general structure, and the realization of matrix-vector, matrix-matrix, and triple-matrix products and such architectures are described. Parallel algorithms for direct and indirect solutions to systems of linear algebraic equations and their implementation on optical systolic processors are detailed with attention to the pipelining and flow of data and operations. Parallel algorithms and their optical realization for LU and QR matrix decomposition are specifically detailed. These represent the fundamental operations necessary in the implementation of least squares, eigenvalue, and SVD solutions. Specific applications (e.g., the solution of partial differential equations, adaptive noise cancellation, and optimal control) are described to typify the use of matrix processors in modern advanced signal processing.

  15. Scalable multi-grid preconditioning techniques for the even-parity S_N solver in UNIC

    International Nuclear Information System (INIS)

    Mahadevan, Vijay S.; Smith, Michael A.

    2011-01-01

    The Even-parity neutron transport equation with FE-S_N discretization is solved traditionally using SOR preconditioned CG method at the lowest level of iterations in order to compute the criticality in reactor analysis problems. The use of high order isoparametric finite elements prohibits the formation of the discrete operator explicitly due to memory constraints in peta scale architectures. Hence, a h-p multi-grid preconditioner based on linear tessellation of the higher order mesh is introduced here for the space-angle system and compared against SOR and Algebraic MG black-box solvers. The performance and scalability of the multi-grid scheme was determined for two test problems and found to be competitive in terms of both computational time and memory requirements. The implementation of this preconditioner in an even-parity solver like UNIC from ANL can further enable high fidelity calculations in a scalable manner on peta flop machines. (author)

  16. An Optimal Order Nonnested Mixed Multigrid Method for Generalized Stokes Problems

    Science.gov (United States)

    Deng, Qingping

    1996-01-01

    A multigrid algorithm is developed and analyzed for generalized Stokes problems discretized by various nonnested mixed finite elements within a unified framework. It is abstractly proved by an element-independent analysis that the multigrid algorithm converges with an optimal order if there exists a 'good' prolongation operator. A technique to construct a 'good' prolongation operator for nonnested multilevel finite element spaces is proposed. Its basic idea is to introduce a sequence of auxiliary nested multilevel finite element spaces and define a prolongation operator as a composite operator of two single grid level operators. This makes not only the construction of a prolongation operator much easier (the final explicit forms of such prolongation operators are fairly simple), but the verification of the approximate properties for prolongation operators is also simplified. Finally, as an application, the framework and technique is applied to seven typical nonnested mixed finite elements.

  17. Optical linear algebra processors - Architectures and algorithms

    Science.gov (United States)

    Casasent, David

    1986-01-01

    Attention is given to the component design and optical configuration features of a generic optical linear algebra processor (OLAP) architecture, as well as the large number of OLAP architectures, number representations, algorithms and applications encountered in current literature. Number-representation issues associated with bipolar and complex-valued data representations, high-accuracy (including floating point) performance, and the base or radix to be employed, are discussed, together with case studies on a space-integrating frequency-multiplexed architecture and a hybrid space-integrating and time-integrating multichannel architecture.

  18. Development of Multigrid Methods for diffusion, Advection, and the incompressible Navier-Stokes Equations

    Energy Technology Data Exchange (ETDEWEB)

    Gjesdal, Thor

    1997-12-31

    This thesis discusses the development and application of efficient numerical methods for the simulation of fluid flows, in particular the flow of incompressible fluids. The emphasis is on practical aspects of algorithm development and on application of the methods either to linear scalar model equations or to the non-linear incompressible Navier-Stokes equations. The first part deals with cell centred multigrid methods and linear correction scheme and presents papers on (1) generalization of the method to arbitrary sized grids for diffusion problems, (2) low order method for advection-diffusion problems, (3) attempt to extend the basic method to advection-diffusion problems, (4) Fourier smoothing analysis of multicolour relaxation schemes, and (5) analysis of high-order discretizations for advection terms. The second part discusses a multigrid based on pressure correction methods, non-linear full approximation scheme, and papers on (1) systematic comparison of the performance of different pressure correction smoothers and some other algorithmic variants, low to moderate Reynolds numbers, and (2) systematic study of implementation strategies for high order advection schemes, high-Re flow. An appendix contains Fortran 90 data structures for multigrid development. 160 refs., 26 figs., 22 tabs.

  19. Application of Symplectic Algebraic Dynamics Algorithm to Circular Restricted Three-Body Problem

    International Nuclear Information System (INIS)

    Wei-Tao, Lu; Hua, Zhang; Shun-Jin, Wang

    2008-01-01

    Symplectic algebraic dynamics algorithm (SADA) for ordinary differential equations is applied to solve numerically the circular restricted three-body problem (CR3BP) in dynamical astronomy for both stable motion and chaotic motion. The result is compared with those of Runge–Kutta algorithm and symplectic algorithm under the fourth order, which shows that SADA has higher accuracy than the others in the long-term calculations of the CR3BP. (general)

  20. A polynomial time algorithm for checking regularity of totally normed process algebra

    NARCIS (Netherlands)

    Yang, F.; Huang, H.

    2015-01-01

    A polynomial algorithm for the regularity problem of weak and branching bisimilarity on totally normed process algebra (PA) processes is given. Its time complexity is O(n 3 +mn) O(n3+mn), where n is the number of transition rules and m is the maximal length of the rules. The algorithm works for

  1. Algébrico: Parte II - Algoritmo Paralelo

    Directory of Open Access Journals (Sweden)

    Fabio Henrique Pereira

    2007-01-01

    Full Text Available In this work, it is presented a new parallel wavelet- based algorithm for the Algebraic Multigrid Method (PWAMG. A variation of the standard parallel implementation of discrete wavelet transforms is used in the construction of a hierarchy of matrices and of intergrid transfer operators for Algebraic Multigrid. The PWAMG method has been tested as a parallel solver for the two dimensional Poisson equation, for different numbers of finite difference mesh nodes and comparisons are made with the sequential version of this method.

  2. Multi-grid and ICCG for problems with interfaces

    International Nuclear Information System (INIS)

    Dendy, J.E.; Hyman, J.M.

    1980-01-01

    Computation times for the multi-grid (MG) algorithm, the incomplete Cholesky conjugate gradient (ICCG) algorithm [J. Comp. Phys. 26, 43-65 (1978); Math. Comp. 31, 148-162 (1977)], and the modified ICCG (MICCG) algorithm [BIT 18, 142-156 (1978)] to solve elliptic partial differential equations are compared. The MICCG and ICCG algorithms are more robust than the MG for general positive definite systems. A major advantage of the MG algorithm is that the structure of the problem can be exploited to reduce the solution time significantly. Five example problems are discussed. For problems with little structure and for one-shot calculations ICCG is recommended over MG, and MICCG, over ICCG. For problems that are done many times, it is worth investing the effort to study methods like MG. 1 table

  3. Summary Report: Multigrid for Systems of Elliptic PDEs

    Energy Technology Data Exchange (ETDEWEB)

    Lee, Barry [Lawrence Livermore National Lab. (LLNL), Livermore, CA (United States)

    2016-11-17

    We are interested in determining if multigrid can be effectively applied to the system. The conclusion that I seem to be drawn to is that it is impossible to develop a blackbox multigrid solver for these general systems. Analysis of the system of PDEs must be conducted first to determine pre-processing procedures on the continuous problem before applying a multigrid method. Determining this pre-processing is currently not incorporated in black-box multigrid strategies. Nevertheless, we characterize some system features that will make the system more amenable to multigrid approaches, techniques that may lead to more amenable systems, and multigrid procedures that are generally more appropriate for these systems.

  4. On the multi-level solution algorithm for Markov chains

    Energy Technology Data Exchange (ETDEWEB)

    Horton, G. [Univ. of Erlangen, Nuernberg (Germany)

    1996-12-31

    We discuss the recently introduced multi-level algorithm for the steady-state solution of Markov chains. The method is based on the aggregation principle, which is well established in the literature. Recursive application of the aggregation yields a multi-level method which has been shown experimentally to give results significantly faster than the methods currently in use. The algorithm can be reformulated as an algebraic multigrid scheme of Galerkin-full approximation type. The uniqueness of the scheme stems from its solution-dependent prolongation operator which permits significant computational savings in the evaluation of certain terms. This paper describes the modeling of computer systems to derive information on performance, measured typically as job throughput or component utilization, and availability, defined as the proportion of time a system is able to perform a certain function in the presence of component failures and possibly also repairs.

  5. Algorithm for solving polynomial algebraic Riccati equations and its application

    Czech Academy of Sciences Publication Activity Database

    Augusta, Petr; Augustová, Petra

    2012-01-01

    Roč. 1, č. 4 (2012), s. 237-242 ISSN 2223-7038 R&D Projects: GA ČR GPP103/12/P494 Institutional support: RVO:67985556 Keywords : Numerical algorithms * algebraic Riccati equation * spatially distributed systems * optimal control Subject RIV: BC - Control Systems Theory http://lib.physcon.ru/doc?id=8b4876d6a57d

  6. GENERAL: Application of Symplectic Algebraic Dynamics Algorithm to Circular Restricted Three-Body Problem

    Science.gov (United States)

    Lu, Wei-Tao; Zhang, Hua; Wang, Shun-Jin

    2008-07-01

    Symplectic algebraic dynamics algorithm (SADA) for ordinary differential equations is applied to solve numerically the circular restricted three-body problem (CR3BP) in dynamical astronomy for both stable motion and chaotic motion. The result is compared with those of Runge-Kutta algorithm and symplectic algorithm under the fourth order, which shows that SADA has higher accuracy than the others in the long-term calculations of the CR3BP.

  7. 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

  8. NONLINEAR MULTIGRID SOLVER EXPLOITING AMGe COARSE SPACES WITH APPROXIMATION PROPERTIES

    Energy Technology Data Exchange (ETDEWEB)

    Christensen, Max La Cour [Technical Univ. of Denmark, Lyngby (Denmark); Villa, Umberto E. [Univ. of Texas, Austin, TX (United States); Engsig-Karup, Allan P. [Technical Univ. of Denmark, Lyngby (Denmark); Vassilevski, Panayot S. [Lawrence Livermore National Lab. (LLNL), Livermore, CA (United States)

    2016-01-22

    The paper introduces a nonlinear multigrid solver for mixed nite element discretizations based on the Full Approximation Scheme (FAS) and element-based Algebraic Multigrid (AMGe). The main motivation to use FAS for unstruc- tured problems is the guaranteed approximation property of the AMGe coarse spaces that were developed recently at Lawrence Livermore National Laboratory. These give the ability to derive stable and accurate coarse nonlinear discretization problems. The previous attempts (including ones with the original AMGe method, [5, 11]), were less successful due to lack of such good approximation properties of the coarse spaces. With coarse spaces with approximation properties, our FAS approach on un- structured meshes should be as powerful/successful as FAS on geometrically re ned meshes. For comparison, Newton's method and Picard iterations with an inner state-of-the-art linear solver is compared to FAS on a nonlinear saddle point problem with applications to porous media ow. It is demonstrated that FAS is faster than Newton's method and Picard iterations for the experiments considered here. Due to the guaranteed approximation properties of our AMGe, the coarse spaces are very accurate, providing a solver with the potential for mesh-independent convergence on general unstructured meshes.

  9. An application of multigrid methods for a discrete elastic model for epitaxial systems

    International Nuclear Information System (INIS)

    Caflisch, R.E.; Lee, Y.-J.; Shu, S.; Xiao, Y.-X.; Xu, J.

    2006-01-01

    We apply an efficient and fast algorithm to simulate the atomistic strain model for epitaxial systems, recently introduced by Schindler et al. [Phys. Rev. B 67, 075316 (2003)]. The discrete effects in this lattice statics model are crucial for proper simulation of the influence of strain for thin film epitaxial growth, but the size of the atomistic systems of interest is in general quite large and hence the solution of the discrete elastic equations is a considerable numerical challenge. In this paper, we construct an algebraic multigrid method suitable for efficient solution of the large scale discrete strain model. Using this method, simulations are performed for several representative physical problems, including an infinite periodic step train, a layered nanocrystal, and a system of quantum dots. The results demonstrate the effectiveness and robustness of the method and show that the method attains optimal convergence properties, regardless of the problem size, the geometry and the physical parameters. The effects of substrate depth and of invariance due to traction-free boundary conditions are assessed. For a system of quantum dots, the simulated strain energy density supports the observations that trench formation near the dots provides strain relief

  10. ADART: an adaptive algebraic reconstruction algorithm for discrete tomography.

    Science.gov (United States)

    Maestre-Deusto, F Javier; Scavello, Giovanni; Pizarro, Joaquín; Galindo, Pedro L

    2011-08-01

    In this paper we suggest an algorithm based on the Discrete Algebraic Reconstruction Technique (DART) which is capable of computing high quality reconstructions from substantially fewer projections than required for conventional continuous tomography. Adaptive DART (ADART) goes a step further than DART on the reduction of the number of unknowns of the associated linear system achieving a significant reduction in the pixel error rate of reconstructed objects. The proposed methodology automatically adapts the border definition criterion at each iteration, resulting in a reduction of the number of pixels belonging to the border, and consequently of the number of unknowns in the general algebraic reconstruction linear system to be solved, being this reduction specially important at the final stage of the iterative process. Experimental results show that reconstruction errors are considerably reduced using ADART when compared to original DART, both in clean and noisy environments.

  11. Multi-grid Beam and Warming scheme for the simulation of unsteady ...

    African Journals Online (AJOL)

    In this paper, a multi-grid algorithm is applied to a large-scale block matrix that is produced from a Beam and Warming scheme. The Beam and Warming scheme is used in the simulation of unsteady flow in an open channel. The Gauss-Seidel block-wise iteration method is used for a smoothing process with a few iterations.

  12. Totally parallel multilevel algorithms

    Science.gov (United States)

    Frederickson, Paul O.

    1988-01-01

    Four totally parallel algorithms for the solution of a sparse linear system have common characteristics which become quite apparent when they are implemented on a highly parallel hypercube such as the CM2. These four algorithms are Parallel Superconvergent Multigrid (PSMG) of Frederickson and McBryan, Robust Multigrid (RMG) of Hackbusch, the FFT based Spectral Algorithm, and Parallel Cyclic Reduction. In fact, all four can be formulated as particular cases of the same totally parallel multilevel algorithm, which are referred to as TPMA. In certain cases the spectral radius of TPMA is zero, and it is recognized to be a direct algorithm. In many other cases the spectral radius, although not zero, is small enough that a single iteration per timestep keeps the local error within the required tolerance.

  13. A comparison between anisotropic analytical and multigrid superposition dose calculation algorithms in radiotherapy treatment planning

    International Nuclear Information System (INIS)

    Wu, Vincent W.C.; Tse, Teddy K.H.; Ho, Cola L.M.; Yeung, Eric C.Y.

    2013-01-01

    Monte Carlo (MC) simulation is currently the most accurate dose calculation algorithm in radiotherapy planning but requires relatively long processing time. Faster model-based algorithms such as the anisotropic analytical algorithm (AAA) by the Eclipse treatment planning system and multigrid superposition (MGS) by the XiO treatment planning system are 2 commonly used algorithms. This study compared AAA and MGS against MC, as the gold standard, on brain, nasopharynx, lung, and prostate cancer patients. Computed tomography of 6 patients of each cancer type was used. The same hypothetical treatment plan using the same machine and treatment prescription was computed for each case by each planning system using their respective dose calculation algorithm. The doses at reference points including (1) soft tissues only, (2) bones only, (3) air cavities only, (4) soft tissue-bone boundary (Soft/Bone), (5) soft tissue-air boundary (Soft/Air), and (6) bone-air boundary (Bone/Air), were measured and compared using the mean absolute percentage error (MAPE), which was a function of the percentage dose deviations from MC. Besides, the computation time of each treatment plan was recorded and compared. The MAPEs of MGS were significantly lower than AAA in all types of cancers (p<0.001). With regards to body density combinations, the MAPE of AAA ranged from 1.8% (soft tissue) to 4.9% (Bone/Air), whereas that of MGS from 1.6% (air cavities) to 2.9% (Soft/Bone). The MAPEs of MGS (2.6%±2.1) were significantly lower than that of AAA (3.7%±2.5) in all tissue density combinations (p<0.001). The mean computation time of AAA for all treatment plans was significantly lower than that of the MGS (p<0.001). Both AAA and MGS algorithms demonstrated dose deviations of less than 4.0% in most clinical cases and their performance was better in homogeneous tissues than at tissue boundaries. In general, MGS demonstrated relatively smaller dose deviations than AAA but required longer computation time

  14. Iterative and multigrid methods in the finite element solution of incompressible and turbulent fluid flow

    Science.gov (United States)

    Lavery, N.; Taylor, C.

    1999-07-01

    Multigrid and iterative methods are used to reduce the solution time of the matrix equations which arise from the finite element (FE) discretisation of the time-independent equations of motion of the incompressible fluid in turbulent motion. Incompressible flow is solved by using the method of reduce interpolation for the pressure to satisfy the Brezzi-Babuska condition. The k-l model is used to complete the turbulence closure problem. The non-symmetric iterative matrix methods examined are the methods of least squares conjugate gradient (LSCG), biconjugate gradient (BCG), conjugate gradient squared (CGS), and the biconjugate gradient squared stabilised (BCGSTAB). The multigrid algorithm applied is based on the FAS algorithm of Brandt, and uses two and three levels of grids with a V-cycling schedule. These methods are all compared to the non-symmetric frontal solver. Copyright

  15. Global identifiability of linear compartmental models--a computer algebra algorithm.

    Science.gov (United States)

    Audoly, S; D'Angiò, L; Saccomani, M P; Cobelli, C

    1998-01-01

    A priori global identifiability deals with the uniqueness of the solution for the unknown parameters of a model and is, thus, a prerequisite for parameter estimation of biological dynamic models. Global identifiability is however difficult to test, since it requires solving a system of algebraic nonlinear equations which increases both in nonlinearity degree and number of terms and unknowns with increasing model order. In this paper, a computer algebra tool, GLOBI (GLOBal Identifiability) is presented, which combines the topological transfer function method with the Buchberger algorithm, to test global identifiability of linear compartmental models. GLOBI allows for the automatic testing of a priori global identifiability of general structure compartmental models from general multi input-multi output experiments. Examples of usage of GLOBI to analyze a priori global identifiability of some complex biological compartmental models are provided.

  16. Multigrid Finite Element Method in Calculation of 3D Homogeneous and Composite Solids

    Directory of Open Access Journals (Sweden)

    A.D. Matveev

    2016-12-01

    Full Text Available In the present paper, a method of multigrid finite elements to calculate elastic three-dimensional homogeneous and composite solids under static loading has been suggested. The method has been developed based on the finite element method algorithms using homogeneous and composite three-dimensional multigrid finite elements (MFE. The procedures for construction of MFE of both rectangular parallelepiped and complex shapes have been shown. The advantages of MFE are that they take into account, following the rules of the microapproach, heterogeneous and microhomogeneous structures of the bodies, describe the three-dimensional stress-strain state (without any simplifying hypotheses in homogeneous and composite solids, as well as generate small dimensional discrete models and numerical solutions with a high accuracy.

  17. Computations in finite-dimensional Lie algebras

    Directory of Open Access Journals (Sweden)

    A. M. Cohen

    1997-12-01

    Full Text Available This paper describes progress made in context with the construction of a general library of Lie algebra algorithms, called ELIAS (Eindhoven Lie Algebra System, within the computer algebra package GAP. A first sketch of the package can be found in Cohen and de Graaf[1]. Since then, in a collaborative effort with G. Ivanyos, the authors have continued to develop algorithms which were implemented in ELIAS by the second author. These activities are part of a bigger project, called ACELA and financed by STW, the Dutch Technology Foundation, which aims at an interactive book on Lie algebras (cf. Cohen and Meertens [2]. This paper gives a global description of the main ways in which to present Lie algebras on a computer. We focus on the transition from a Lie algebra abstractly given by an array of structure constants to a Lie algebra presented as a subalgebra of the Lie algebra of n×n matrices. We describe an algorithm typical of the structure analysis of a finite-dimensional Lie algebra: finding a Levi subalgebra of a Lie algebra.

  18. Toward textbook multigrid efficiency for fully implicit resistive magnetohydrodynamics

    International Nuclear Information System (INIS)

    Adams, Mark F.; Samtaney, Ravi; Brandt, Achi

    2010-01-01

    Multigrid methods can solve some classes of elliptic and parabolic equations to accuracy below the truncation error with a work-cost equivalent to a few residual calculations - so-called 'textbook' multigrid efficiency. We investigate methods to solve the system of equations that arise in time dependent magnetohydrodynamics (MHD) simulations with textbook multigrid efficiency. We apply multigrid techniques such as geometric interpolation, full approximate storage, Gauss-Seidel smoothers, and defect correction for fully implicit, nonlinear, second-order finite volume discretizations of MHD. We apply these methods to a standard resistive MHD benchmark problem, the GEM reconnection problem, and add a strong magnetic guide field, which is a critical characteristic of magnetically confined fusion plasmas. We show that our multigrid methods can achieve near textbook efficiency on fully implicit resistive MHD simulations.

  19. Toward textbook multigrid efficiency for fully implicit resistive magnetohydrodynamics

    International Nuclear Information System (INIS)

    Adams, Mark F.; Samtaney, Ravi; Brandt, Achi

    2013-01-01

    Multigrid methods can solve some classes of elliptic and parabolic equations to accuracy below the truncation error with a work-cost equivalent to a few residual calculations so-called textbook multigrid efficiency. We investigate methods to solve the system of equations that arise in time dependent magnetohydrodynamics (MHD) simulations with textbook multigrid efficiency. We apply multigrid techniques such as geometric interpolation, full approximate storage, Gauss-Seidel smoothers, and defect correction for fully implicit, nonlinear, second-order finite volume discretizations of MHD. We apply these methods to a standard resistive MHD benchmark problem, the GEM reconnection problem, and add a strong magnetic guide field, which is a critical characteristic of magnetically confined fusion plasmas. We show that our multigrid methods can achieve near textbook efficiency on fully implicit resistive MHD simulations.

  20. A Critical Study of Agglomerated Multigrid Methods for Diffusion

    Science.gov (United States)

    Nishikawa, Hiroaki; Diskin, Boris; Thomas, James L.

    2011-01-01

    Agglomerated multigrid techniques used in unstructured-grid methods are studied critically for a model problem representative of laminar diffusion in the incompressible limit. The studied target-grid discretizations and discretizations used on agglomerated grids are typical of current node-centered formulations. Agglomerated multigrid convergence rates are presented using a range of two- and three-dimensional randomly perturbed unstructured grids for simple geometries with isotropic and stretched grids. Two agglomeration techniques are used within an overall topology-preserving agglomeration framework. The results show that multigrid with an inconsistent coarse-grid scheme using only the edge terms (also referred to in the literature as a thin-layer formulation) provides considerable speedup over single-grid methods but its convergence deteriorates on finer grids. Multigrid with a Galerkin coarse-grid discretization using piecewise-constant prolongation and a heuristic correction factor is slower and also grid-dependent. In contrast, grid-independent convergence rates are demonstrated for multigrid with consistent coarse-grid discretizations. Convergence rates of multigrid cycles are verified with quantitative analysis methods in which parts of the two-grid cycle are replaced by their idealized counterparts.

  1. Fast algorithms for transport models. Final report, June 1, 1993--May 31, 1994

    International Nuclear Information System (INIS)

    Manteuffel, T.

    1994-12-01

    The focus of this project is the study of multigrid and multilevel algorithms for the numerical solution of Boltzmann models of the transport of neutral and charged particles. In previous work a fast multigrid algorithm was developed for the numerical solution of the Boltzmann model of neutral particle transport in slab geometry assuming isotropic scattering. The new algorithm is extremely fast in the thick diffusion limit; the multigrid v-cycle convergence factor approaches zero as the mean-free-path between collisions approaches zero, independent of the mesh. Also, a fast multilevel method was developed for the numerical solution of the Boltzmann model of charged particle transport in the thick Fokker-Plank limit for slab geometry. Parallel implementations were developed for both algorithms

  2. Multigrid preconditioning of the generator two-phase mixture balance equations in the Genepi software

    International Nuclear Information System (INIS)

    Belliard, M.; Grandotto, M.

    2003-01-01

    In the framework of the two-phase fluid simulations of the steam generators of pressurized water nuclear reactors, we present in this paper a geometric version of a pseudo-Full MultiGrid (pseudo- FMG) Full Approximation Storage (FAS) preconditioning of balance equations in the GENEPI code. In our application, the 3D steady state flow is reached by a transient computation using a semi-implicit fractional step algorithm for the averaged two-phase mixture balance equations (mass, momentum and energy for the secondary flow). Our application, running on workstation clusters, is based on a CEA code-linker and the PVM package. The difficulties to apply the geometric FAS multigrid method to the momentum and mass balance equations are addressed. The use of a sequential pseudo-FMG FAS twogrid method for both energy and mass/momentum balance equations, using dynamic multigrid cycles, leads to perceptibly improvements in the computation convergences. An original parallel red-black pseudo-FMG FAS three-grid algorithm is presented too. The numerical tests (steam generator mockup simulations) underline the sizable increase in speed of convergence of the computations, essentially for the ones involving a large number of freedom degrees (about 100 thousand cells). The two-phase mixture balance equation residuals are quickly reduced: the reached speed-up stands between 2 and 3 following the number of grids. The effects on the convergence behavior of the numerical parameters are investigated

  3. Toward textbook multigrid efficiency for fully implicit resistive magnetohydrodynamics

    KAUST Repository

    Adams, Mark F.; Samtaney, Ravi; Brandt, Achi

    2010-01-01

    Multigrid methods can solve some classes of elliptic and parabolic equations to accuracy below the truncation error with a work-cost equivalent to a few residual calculations so-called "textbook" multigrid efficiency. We investigate methods to solve the system of equations that arise in time dependent magnetohydrodynamics (MHD) simulations with textbook multigrid efficiency. We apply multigrid techniques such as geometric interpolation, full approximate storage, Gauss-Seidel smoothers, and defect correction for fully implicit, nonlinear, second-order finite volume discretizations of MHD. We apply these methods to a standard resistive MHD benchmark problem, the GEM reconnection problem, and add a strong magnetic guide field, which is a critical characteristic of magnetically confined fusion plasmas. We show that our multigrid methods can achieve near textbook efficiency on fully implicit resistive MHD simulations. (C) 2010 Elsevier Inc. All rights reserved.

  4. Toward textbook multigrid efficiency for fully implicit resistive magnetohydrodynamics

    KAUST Repository

    Adams, Mark F.

    2010-09-01

    Multigrid methods can solve some classes of elliptic and parabolic equations to accuracy below the truncation error with a work-cost equivalent to a few residual calculations so-called "textbook" multigrid efficiency. We investigate methods to solve the system of equations that arise in time dependent magnetohydrodynamics (MHD) simulations with textbook multigrid efficiency. We apply multigrid techniques such as geometric interpolation, full approximate storage, Gauss-Seidel smoothers, and defect correction for fully implicit, nonlinear, second-order finite volume discretizations of MHD. We apply these methods to a standard resistive MHD benchmark problem, the GEM reconnection problem, and add a strong magnetic guide field, which is a critical characteristic of magnetically confined fusion plasmas. We show that our multigrid methods can achieve near textbook efficiency on fully implicit resistive MHD simulations. (C) 2010 Elsevier Inc. All rights reserved.

  5. 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.

  6. Ideals, varieties, and algorithms an introduction to computational algebraic geometry and commutative algebra

    CERN Document Server

    Cox, David A; O'Shea, Donal

    2015-01-01

    This text covers topics in algebraic geometry and commutative algebra with a strong perspective toward practical and computational aspects. The first four chapters form the core of the book. A comprehensive chart in the preface illustrates a variety of ways to proceed with the material once these chapters are covered. In addition to the fundamentals of algebraic geometry—the elimination theorem, the extension theorem, the closure theorem, and the Nullstellensatz—this new edition incorporates several substantial changes, all of which are listed in the Preface. The largest revision incorporates a new chapter (ten), which presents some of the essentials of progress made over the last decades in computing Gröbner bases. The book also includes current computer algebra material in Appendix C and updated independent projects (Appendix D). The book may serve as a first or second course in undergraduate abstract algebra and, with some supplementation perhaps, for beginning graduate level courses in algebraic geom...

  7. Linear algebra

    CERN Document Server

    Edwards, Harold M

    1995-01-01

    In his new undergraduate textbook, Harold M Edwards proposes a radically new and thoroughly algorithmic approach to linear algebra Originally inspired by the constructive philosophy of mathematics championed in the 19th century by Leopold Kronecker, the approach is well suited to students in the computer-dominated late 20th century Each proof is an algorithm described in English that can be translated into the computer language the class is using and put to work solving problems and generating new examples, making the study of linear algebra a truly interactive experience Designed for a one-semester course, this text adopts an algorithmic approach to linear algebra giving the student many examples to work through and copious exercises to test their skills and extend their knowledge of the subject Students at all levels will find much interactive instruction in this text while teachers will find stimulating examples and methods of approach to the subject

  8. A matrix-algebraic algorithm for the Riemannian logarithm on the Stiefel manifold under the canonical metric

    DEFF Research Database (Denmark)

    Zimmermann, Ralf

    2017-01-01

    We derive a numerical algorithm for evaluating the Riemannian logarithm on the Stiefel manifold with respect to the canonical metric. In contrast to the optimization-based approach known from the literature, we work from a purely matrix-algebraic perspective. Moreover, we prove that the algorithm...... converges locally and exhibits a linear rate of convergence....

  9. A matrix-algebraic algorithm for the Riemannian logarithm on the Stiefel manifold under the canonical metric

    OpenAIRE

    Zimmermann, Ralf

    2016-01-01

    We derive a numerical algorithm for evaluating the Riemannian logarithm on the Stiefel manifold with respect to the canonical metric. In contrast to the optimization-based approach known from the literature, we work from a purely matrix-algebraic perspective. Moreover, we prove that the algorithm converges locally and exhibits a linear rate of convergence.

  10. The relation between quantum W algebras and Lie algebras

    International Nuclear Information System (INIS)

    Boer, J. de; Tjin, T.

    1994-01-01

    By quantizing the generalized Drinfeld-Sokolov reduction scheme for arbitrary sl 2 embeddings we show that a large set W of quantum W algebras can be viewed as (BRST) cohomologies of affine Lie algebras. The set W contains many known W algebras such as W N and W 3 (2) . Our formalism yields a completely algorithmic method for calculating the W algebra generators and their operator product expansions, replacing the cumbersome construction of W algebras as commutants of screening operators. By generalizing and quantizing the Miura transformation we show that any W algebra in W can be embedded into the universal enveloping algebra of a semisimple affine Lie algebra which is, up to shifts in level, isomorphic to a subalgebra of the original affine algebra. Therefore any realization of this semisimple affine Lie algebra leads to a realization of the W algebra. In particular, one obtains in this way a general and explicit method for constructing the free field realizations and Fock resolutions for all algebras in W. Some examples are explicitly worked out. (orig.)

  11. 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.

  12. Cellular Genetic Algorithm with Communicating Grids for Assembly Line Balancing Problems

    Directory of Open Access Journals (Sweden)

    BRUDARU, O.

    2010-05-01

    Full Text Available This paper presents a new approach with cellular multigrid genetic algorithms for the "I"-shaped and "U"-shaped assembly line balancing problems, including parallel workstations and compatibility constraints. First, a cellular hybrid genetic algorithm that uses a single grid is described. Appropriate operators for mutation, hypermutation, and crossover and two devoration techniques are proposed for creating and maintaining groups based on similarity. This monogrid algorithm is extended for handling many populations placed on different grids. In the multigrid version, the population of each grid is organized in clusters using the positional information of the chromosomes. A similarity preserving communication protocol between the clusters placed on different grids is introduced. The experimental evaluation shows that the multigrid cellular genetic algorithm with communicating grids is better than the hybrid genetic algorithm used for building it, whereas it dominates the monogrid version in all cases. Absolute performance is evaluated using classical benchmarks. The role of certain components of the cellular algorithm is explained and the effect of some parameters is evaluated.

  13. On the fixed-stress split scheme as smoother in multigrid methods for coupling flow and geomechanics

    NARCIS (Netherlands)

    F.J. Gaspar Lorenz (Franscisco); C. Rodrigo (Carmen)

    2017-01-01

    textabstractThe fixed-stress split method has been widely used as solution method in the coupling of flow and geomechanics. In this work, we analyze the behavior of an inexact version of this algorithm as smoother within a geometric multigrid method, in order to obtain an efficient monolithic solver

  14. The Automation of Stochastization Algorithm with Use of SymPy Computer Algebra Library

    Science.gov (United States)

    Demidova, Anastasya; Gevorkyan, Migran; Kulyabov, Dmitry; Korolkova, Anna; Sevastianov, Leonid

    2018-02-01

    SymPy computer algebra library is used for automatic generation of ordinary and stochastic systems of differential equations from the schemes of kinetic interaction. Schemes of this type are used not only in chemical kinetics but also in biological, ecological and technical models. This paper describes the automatic generation algorithm with an emphasis on application details.

  15. Profiling high performance dense linear algebra algorithms on multicore architectures for power and energy efficiency

    KAUST Repository

    Ltaief, Hatem; Luszczek, Piotr R.; Dongarra, Jack

    2011-01-01

    This paper presents the power profile of two high performance dense linear algebra libraries i.e., LAPACK and PLASMA. The former is based on block algorithms that use the fork-join paradigm to achieve parallel performance. The latter uses fine

  16. Segmental Refinement: A Multigrid Technique for Data Locality

    Energy Technology Data Exchange (ETDEWEB)

    Adams, Mark [Columbia Univ., New York, NY (United States). Applied Physics and Applied Mathematics Dept.; Lawrence Berkeley National Lab. (LBNL), Berkeley, CA (United States)

    2014-10-27

    We investigate a technique - segmental refinement (SR) - proposed by Brandt in the 1970s as a low memory multigrid method. The technique is attractive for modern computer architectures because it provides high data locality, minimizes network communication, is amenable to loop fusion, and is naturally highly parallel and asynchronous. The network communication minimization property was recognized by Brandt and Diskin in 1994; we continue this work by developing a segmental refinement method for a finite volume discretization of the 3D Laplacian on massively parallel computers. An understanding of the asymptotic complexities, required to maintain textbook multigrid efficiency, are explored experimentally with a simple SR method. A two-level memory model is developed to compare the asymptotic communication complexity of a proposed SR method with traditional parallel multigrid. Performance and scalability are evaluated with a Cray XC30 with up to 64K cores. We achieve modest improvement in scalability from traditional parallel multigrid with a simple SR implementation.

  17. Segmental Refinement: A Multigrid Technique for Data Locality

    KAUST Repository

    Adams, Mark F.; Brown, Jed; Knepley, Matt; Samtaney, Ravi

    2016-01-01

    We investigate a domain decomposed multigrid technique, termed segmental refinement, for solving general nonlinear elliptic boundary value problems. We extend the method first proposed in 1994 by analytically and experimentally investigating its complexity. We confirm that communication of traditional parallel multigrid is eliminated on fine grids, with modest amounts of extra work and storage, while maintaining the asymptotic exactness of full multigrid. We observe an accuracy dependence on the segmental refinement subdomain size, which was not considered in the original analysis. We present a communication complexity analysis that quantifies the communication costs ameliorated by segmental refinement and report performance results with up to 64K cores on a Cray XC30.

  18. Segmental Refinement: A Multigrid Technique for Data Locality

    KAUST Repository

    Adams, Mark F.

    2016-08-04

    We investigate a domain decomposed multigrid technique, termed segmental refinement, for solving general nonlinear elliptic boundary value problems. We extend the method first proposed in 1994 by analytically and experimentally investigating its complexity. We confirm that communication of traditional parallel multigrid is eliminated on fine grids, with modest amounts of extra work and storage, while maintaining the asymptotic exactness of full multigrid. We observe an accuracy dependence on the segmental refinement subdomain size, which was not considered in the original analysis. We present a communication complexity analysis that quantifies the communication costs ameliorated by segmental refinement and report performance results with up to 64K cores on a Cray XC30.

  19. Least-squares wave-front reconstruction of Shack-Hartmann sensors and shearing interferometers using multigrid techniques

    International Nuclear Information System (INIS)

    Baker, K.L.

    2005-01-01

    This article details a multigrid algorithm that is suitable for least-squares wave-front reconstruction of Shack-Hartmann and shearing interferometer wave-front sensors. The algorithm detailed in this article is shown to scale with the number of subapertures in the same fashion as fast Fourier transform techniques, making it suitable for use in applications requiring a large number of subapertures and high Strehl ratio systems such as for high spatial frequency characterization of high-density plasmas, optics metrology, and multiconjugate and extreme adaptive optics systems

  20. Computer algebra and operators

    Science.gov (United States)

    Fateman, Richard; Grossman, Robert

    1989-01-01

    The symbolic computation of operator expansions is discussed. Some of the capabilities that prove useful when performing computer algebra computations involving operators are considered. These capabilities may be broadly divided into three areas: the algebraic manipulation of expressions from the algebra generated by operators; the algebraic manipulation of the actions of the operators upon other mathematical objects; and the development of appropriate normal forms and simplification algorithms for operators and their actions. Brief descriptions are given of the computer algebra computations that arise when working with various operators and their actions.

  1. Matrix-dependent multigrid-homogenization for diffusion problems

    Energy Technology Data Exchange (ETDEWEB)

    Knapek, S. [Institut fuer Informatik tu Muenchen (Germany)

    1996-12-31

    We present a method to approximately determine the effective diffusion coefficient on the coarse scale level of problems with strongly varying or discontinuous diffusion coefficients. It is based on techniques used also in multigrid, like Dendy`s matrix-dependent prolongations and the construction of coarse grid operators by means of the Galerkin approximation. In numerical experiments, we compare our multigrid-homogenization method with homogenization, renormalization and averaging approaches.

  2. Classification and identification of Lie algebras

    CERN Document Server

    Snobl, Libor

    2014-01-01

    The purpose of this book is to serve as a tool for researchers and practitioners who apply Lie algebras and Lie groups to solve problems arising in science and engineering. The authors address the problem of expressing a Lie algebra obtained in some arbitrary basis in a more suitable basis in which all essential features of the Lie algebra are directly visible. This includes algorithms accomplishing decomposition into a direct sum, identification of the radical and the Levi decomposition, and the computation of the nilradical and of the Casimir invariants. Examples are given for each algorithm. For low-dimensional Lie algebras this makes it possible to identify the given Lie algebra completely. The authors provide a representative list of all Lie algebras of dimension less or equal to 6 together with their important properties, including their Casimir invariants. The list is ordered in a way to make identification easy, using only basis independent properties of the Lie algebras. They also describe certain cl...

  3. Computer algebra applications

    International Nuclear Information System (INIS)

    Calmet, J.

    1982-01-01

    A survey of applications based either on fundamental algorithms in computer algebra or on the use of a computer algebra system is presented. Recent work in biology, chemistry, physics, mathematics and computer science is discussed. In particular, applications in high energy physics (quantum electrodynamics), celestial mechanics and general relativity are reviewed. (Auth.)

  4. Quantum complexity of graph and algebraic problems

    International Nuclear Information System (INIS)

    Doern, Sebastian

    2008-01-01

    This thesis is organized as follows: In Chapter 2 we give some basic notations, definitions and facts from linear algebra, graph theory, group theory and quantum computation. In Chapter 3 we describe three important methods for the construction of quantum algorithms. We present the quantum search algorithm by Grover, the quantum amplitude amplification and the quantum walk search technique by Magniez et al. These three tools are the basis for the development of our new quantum algorithms for graph and algebra problems. In Chapter 4 we present two tools for proving quantum query lower bounds. We present the quantum adversary method by Ambainis and the polynomial method introduced by Beals et al. The quantum adversary tool is very useful to prove good lower bounds for many graph and algebra problems. The part of the thesis containing the original results is organized in two parts. In the first part we consider the graph problems. In Chapter 5 we give a short summary of known quantum graph algorithms. In Chapter 6 to 8 we study the complexity of our new algorithms for matching problems, graph traversal and independent set problems on quantum computers. In the second part of our thesis we present new quantum algorithms for algebraic problems. In Chapter 9 to 10 we consider group testing problems and prove quantum complexity bounds for important problems from linear algebra. (orig.)

  5. Quantum complexity of graph and algebraic problems

    Energy Technology Data Exchange (ETDEWEB)

    Doern, Sebastian

    2008-02-04

    This thesis is organized as follows: In Chapter 2 we give some basic notations, definitions and facts from linear algebra, graph theory, group theory and quantum computation. In Chapter 3 we describe three important methods for the construction of quantum algorithms. We present the quantum search algorithm by Grover, the quantum amplitude amplification and the quantum walk search technique by Magniez et al. These three tools are the basis for the development of our new quantum algorithms for graph and algebra problems. In Chapter 4 we present two tools for proving quantum query lower bounds. We present the quantum adversary method by Ambainis and the polynomial method introduced by Beals et al. The quantum adversary tool is very useful to prove good lower bounds for many graph and algebra problems. The part of the thesis containing the original results is organized in two parts. In the first part we consider the graph problems. In Chapter 5 we give a short summary of known quantum graph algorithms. In Chapter 6 to 8 we study the complexity of our new algorithms for matching problems, graph traversal and independent set problems on quantum computers. In the second part of our thesis we present new quantum algorithms for algebraic problems. In Chapter 9 to 10 we consider group testing problems and prove quantum complexity bounds for important problems from linear algebra. (orig.)

  6. A multigrid method for variational inequalities

    Energy Technology Data Exchange (ETDEWEB)

    Oliveira, S.; Stewart, D.E.; Wu, W.

    1996-12-31

    Multigrid methods have been used with great success for solving elliptic partial differential equations. Penalty methods have been successful in solving finite-dimensional quadratic programs. In this paper these two techniques are combined to give a fast method for solving obstacle problems. A nonlinear penalized problem is solved using Newton`s method for large values of a penalty parameter. Multigrid methods are used to solve the linear systems in Newton`s method. The overall numerical method developed is based on an exterior penalty function, and numerical results showing the performance of the method have been obtained.

  7. 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.

  8. Elements of algebraic coding systems

    CERN Document Server

    Cardoso da Rocha, Jr, Valdemar

    2014-01-01

    Elements of Algebraic Coding Systems is an introductory text to algebraic coding theory. In the first chapter, you'll gain inside knowledge of coding fundamentals, which is essential for a deeper understanding of state-of-the-art coding systems. This book is a quick reference for those who are unfamiliar with this topic, as well as for use with specific applications such as cryptography and communication. Linear error-correcting block codes through elementary principles span eleven chapters of the text. Cyclic codes, some finite field algebra, Goppa codes, algebraic decoding algorithms, and applications in public-key cryptography and secret-key cryptography are discussed, including problems and solutions at the end of each chapter. Three appendices cover the Gilbert bound and some related derivations, a derivation of the Mac- Williams' identities based on the probability of undetected error, and two important tools for algebraic decoding-namely, the finite field Fourier transform and the Euclidean algorithm f...

  9. Algebraic Side-Channel Attack on Twofish

    Directory of Open Access Journals (Sweden)

    Chujiao Ma

    2017-05-01

    Full Text Available While algebraic side-channel attack (ASCA has been successful in breaking simple cryptographic algorithms, it has never been done on larger or more complex algorithms such as Twofish. Compared to other algorithms that ASCA has been used on, Twofish is more difficult to attack due to the key-dependent S-boxes as well as the complex key scheduling. In this paper, we propose the first algebraic side-channel attack on Twofish, and examine the importance of side-channel information in getting past the key-dependent S-boxes and the complex key scheduling. The cryptographic algorithm and side-channel information are both expressed as boolean equations and a SAT solver is used to recover the key. While algebraic attack by itself is not sufficient to break the algorithm, with the help of side-channel information such as Hamming weights, we are able to correctly solve for 96 bits of the 128 bits key in under 2 hours with known plaintext/ciphertext.

  10. Distance-two interpolation for parallel algebraic multigrid

    International Nuclear Information System (INIS)

    Sterck, H de; Falgout, R D; Nolting, J W; Yang, U M

    2007-01-01

    In this paper we study the use of long distance interpolation methods with the low complexity coarsening algorithm PMIS. AMG performance and scalability is compared for classical as well as long distance interpolation methods on parallel computers. It is shown that the increased interpolation accuracy largely restores the scalability of AMG convergence factors for PMIS-coarsened grids, and in combination with complexity reducing methods, such as interpolation truncation, one obtains a class of parallel AMG methods that enjoy excellent scalability properties on large parallel computers

  11. Templates for Linear Algebra Problems

    NARCIS (Netherlands)

    Bai, Z.; Day, D.; Demmel, J.; Dongarra, J.; Gu, M.; Ruhe, A.; Vorst, H.A. van der

    1995-01-01

    The increasing availability of advanced-architecture computers is having a very signicant eect on all spheres of scientic computation, including algorithm research and software development in numerical linear algebra. Linear algebra {in particular, the solution of linear systems of equations and

  12. Multiscale Monte Carlo algorithms in statistical mechanics and quantum field theory

    Energy Technology Data Exchange (ETDEWEB)

    Lauwers, P G

    1990-12-01

    Conventional Monte Carlo simulation algorithms for models in statistical mechanics and quantum field theory are afflicted by problems caused by their locality. They become highly inefficient if investigations of critical or nearly-critical systems, i.e., systems with important large scale phenomena, are undertaken. We present two types of multiscale approaches that alleveate problems of this kind: Stochastic cluster algorithms and multigrid Monte Carlo simulation algorithms. Another formidable computational problem in simulations of phenomenologically relevant field theories with fermions is the need for frequently inverting the Dirac operator. This inversion can be accelerated considerably by means of deterministic multigrid methods, very similar to the ones used for the numerical solution of differential equations. (orig.).

  13. A multigrid solution method for mixed hybrid finite elements

    Energy Technology Data Exchange (ETDEWEB)

    Schmid, W. [Universitaet Augsburg (Germany)

    1996-12-31

    We consider the multigrid solution of linear equations arising within the discretization of elliptic second order boundary value problems of the form by mixed hybrid finite elements. Using the equivalence of mixed hybrid finite elements and non-conforming nodal finite elements, we construct a multigrid scheme for the corresponding non-conforming finite elements, and, by this equivalence, for the mixed hybrid finite elements, following guidelines from Arbogast/Chen. For a rectangular triangulation of the computational domain, this non-conforming schemes are the so-called nodal finite elements. We explicitly construct prolongation and restriction operators for this type of non-conforming finite elements. We discuss the use of plain multigrid and the multilevel-preconditioned cg-method and compare their efficiency in numerical tests.

  14. A NetCDF version of the two-dimensional energy balance model based on the full multigrid algorithm

    Directory of Open Access Journals (Sweden)

    Kelin Zhuang

    2017-01-01

    Full Text Available A NetCDF version of the two-dimensional energy balance model based on the full multigrid method in Fortran is introduced for both pedagogical and research purposes. Based on the land–sea–ice distribution, orbital elements, greenhouse gases concentration, and albedo, the code calculates the global seasonal surface temperature. A step-by-step guide with examples is provided for practice.

  15. A NetCDF version of the two-dimensional energy balance model based on the full multigrid algorithm

    Science.gov (United States)

    Zhuang, Kelin; North, Gerald R.; Stevens, Mark J.

    A NetCDF version of the two-dimensional energy balance model based on the full multigrid method in Fortran is introduced for both pedagogical and research purposes. Based on the land-sea-ice distribution, orbital elements, greenhouse gases concentration, and albedo, the code calculates the global seasonal surface temperature. A step-by-step guide with examples is provided for practice.

  16. Algorithms of estimation for nonlinear systems a differential and algebraic viewpoint

    CERN Document Server

    Martínez-Guerra, Rafael

    2017-01-01

    This book acquaints readers with recent developments in dynamical systems theory and its applications, with a strong focus on the control and estimation of nonlinear systems. Several algorithms are proposed and worked out for a set of model systems, in particular so-called input-affine or bilinear systems, which can serve to approximate a wide class of nonlinear control systems. These can either take the form of state space models or be represented by an input-output equation. The approach taken here further highlights the role of modern mathematical and conceptual tools, including differential algebraic theory, observer design for nonlinear systems and generalized canonical forms.

  17. Multigrid solution of diffusion equations on distributed memory multiprocessor systems

    International Nuclear Information System (INIS)

    Finnemann, H.

    1988-01-01

    The subject is the solution of partial differential equations for simulation of the reactor core on high-performance computers. The parallelization and implementation of nodal multigrid diffusion algorithms on array and ring configurations of the DIRMU multiprocessor system is outlined. The particular iteration scheme employed in the nodal expansion method appears similarly efficient in serial and parallel environments. The combination of modern multi-level techniques with innovative hardware (vector-multiprocessor systems) provides powerful tools needed for real time simulation of physical systems. The parallel efficiencies range from 70 to 90%. The same performance is estimated for large problems on large multiprocessor systems being designed at present. (orig.) [de

  18. Experiences using multigrid for geothermal simulation

    Energy Technology Data Exchange (ETDEWEB)

    Bullivant, D.P.; O`Sullivan, M.J. [Univ. of Auckland (New Zealand); Yang, Z. [Univ. of New South Wales (Australia)

    1995-03-01

    Experiences of applying multigrid to the calculation of natural states for geothermal simulations are discussed. The modelling of natural states was chosen for this study because they can take a long time to compute and the computation is often dominated by the development of phase change boundaries that take up a small region in the simulation. For the first part of this work a modified version of TOUGH was used for 2-D vertical problems. A {open_quotes}test-bed{close_quotes} program is now being used to investigate some of the problems encountered with implementing multigrid. This is ongoing work. To date, there have been some encouraging but not startling results.

  19. Numerical linear algebra theory and applications

    CERN Document Server

    Beilina, Larisa; Karchevskii, Mikhail

    2017-01-01

    This book combines a solid theoretical background in linear algebra with practical algorithms for numerical solution of linear algebra problems. Developed from a number of courses taught repeatedly by the authors, the material covers topics like matrix algebra, theory for linear systems of equations, spectral theory, vector and matrix norms combined with main direct and iterative numerical methods, least squares problems, and eigen problems. Numerical algorithms illustrated by computer programs written in MATLAB® are also provided as supplementary material on SpringerLink to give the reader a better understanding of professional numerical software for the solution of real-life problems. Perfect for a one- or two-semester course on numerical linear algebra, matrix computation, and large sparse matrices, this text will interest students at the advanced undergraduate or graduate level.

  20. Non-freely generated W-algebras and construction of N=2 super W-algebras

    International Nuclear Information System (INIS)

    Blumenhagen, R.

    1994-07-01

    Firstly, we investigate the origin of the bosonic W-algebras W(2, 3, 4, 5), W(2, 4, 6) and W(2, 4, 6) found earlier by direct construction. We present a coset construction for all three examples leading to a new type of finitely, non-freely generated quantum W-algebras, which we call unifying W-algebras. Secondly, we develop a manifest covariant formalism to construct N = 2 super W-algebras explicitly on a computer. Applying this algorithm enables us to construct the first four examples of N = 2 super W-algebras with two generators and the N = 2 super W 4 algebra involving three generators. The representation theory of the former ones shows that all examples could be divided into four classes, the largest one containing the N = 2 special type of spectral flow algebras. Besides the W-algebra of the CP(3) Kazama-Suzuki coset model, the latter example with three generators discloses a second solution which could also be explained as a unifying W-algebra for the CP(n) models. (orig.)

  1. 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%.

  2. Construction and decoding of a class of algebraic geometry codes

    DEFF Research Database (Denmark)

    Justesen, Jørn; Larsen, Knud J.; Jensen, Helge Elbrønd

    1989-01-01

    A class of codes derived from algebraic plane curves is constructed. The concepts and results from algebraic geometry that were used are explained in detail; no further knowledge of algebraic geometry is needed. Parameters, generator and parity-check matrices are given. The main result is a decod...... is a decoding algorithm which turns out to be a generalization of the Peterson algorithm for decoding BCH decoder codes......A class of codes derived from algebraic plane curves is constructed. The concepts and results from algebraic geometry that were used are explained in detail; no further knowledge of algebraic geometry is needed. Parameters, generator and parity-check matrices are given. The main result...

  3. Algebraic curves and cryptography

    CERN Document Server

    Murty, V Kumar

    2010-01-01

    It is by now a well-known paradigm that public-key cryptosystems can be built using finite Abelian groups and that algebraic geometry provides a supply of such groups through Abelian varieties over finite fields. Of special interest are the Abelian varieties that are Jacobians of algebraic curves. All of the articles in this volume are centered on the theme of point counting and explicit arithmetic on the Jacobians of curves over finite fields. The topics covered include Schoof's \\ell-adic point counting algorithm, the p-adic algorithms of Kedlaya and Denef-Vercauteren, explicit arithmetic on

  4. New matrix bounds and iterative algorithms for the discrete coupled algebraic Riccati equation

    Science.gov (United States)

    Liu, Jianzhou; Wang, Li; Zhang, Juan

    2017-11-01

    The discrete coupled algebraic Riccati equation (DCARE) has wide applications in control theory and linear system. In general, for the DCARE, one discusses every term of the coupled term, respectively. In this paper, we consider the coupled term as a whole, which is different from the recent results. When applying eigenvalue inequalities to discuss the coupled term, our method has less error. In terms of the properties of special matrices and eigenvalue inequalities, we propose several upper and lower matrix bounds for the solution of DCARE. Further, we discuss the iterative algorithms for the solution of the DCARE. In the fixed point iterative algorithms, the scope of Lipschitz factor is wider than the recent results. Finally, we offer corresponding numerical examples to illustrate the effectiveness of the derived results.

  5. Investigations on application of multigrid method to MHD equilibrium analysis

    International Nuclear Information System (INIS)

    Ikuno, Soichiro

    2000-01-01

    The potentiality of application for Multi-grid method to MHD equilibrium analysis is investigated. The nonlinear eigenvalue problem often appears when the MHD equilibria are determined by solving the Grad-Shafranov equation numerically. After linearization of the equation, the problem is solved by use of the iterative method. Although the Red-Black SOR method or Gauss-Seidel method is often used for the solution of the linearized equation, it takes much CPU time to solve the problem. The Multi-grid method is compared with the SOR method for the Poisson Problem. The results of computations show that the CPU time required for the Multi-grid method is about 1000 times as small as that for the SOR method. (author)

  6. A differential algebraic integration algorithm for symplectic mappings in systems with three-dimensional magnetic field

    International Nuclear Information System (INIS)

    Chang, P.; Lee, S.Y.; Yan, Y.T.

    2006-01-01

    A differential algebraic integration algorithm is developed for symplectic mapping through a three-dimensional (3-D) magnetic field. The self-consistent reference orbit in phase space is obtained by making a canonical transformation to eliminate the linear part of the Hamiltonian. Transfer maps from the entrance to the exit of any 3-D magnetic field are then obtained through slice-by-slice symplectic integration. The particle phase-space coordinates are advanced by using the integrable polynomial procedure. This algorithm is a powerful tool to attain nonlinear maps for insertion devices in synchrotron light source or complicated magnetic field in the interaction region in high energy colliders

  7. A Differential Algebraic Integration Algorithm for Symplectic Mappings in Systems with Three-Dimensional Magnetic Field

    International Nuclear Information System (INIS)

    Chang, P

    2004-01-01

    A differential algebraic integration algorithm is developed for symplectic mapping through a three-dimensional (3-D) magnetic field. The self-consistent reference orbit in phase space is obtained by making a canonical transformation to eliminate the linear part of the Hamiltonian. Transfer maps from the entrance to the exit of any 3-D magnetic field are then obtained through slice-by-slice symplectic integration. The particle phase-space coordinates are advanced by using the integrable polynomial procedure. This algorithm is a powerful tool to attain nonlinear maps for insertion devices in synchrotron light source or complicated magnetic field in the interaction region in high energy colliders

  8. FINAL REPORT (MILESTONE DATE 9/30/11) FOR SUBCONTRACT NO. B594099 NUMERICAL METHODS FOR LARGE-SCALE DATA FACTORIZATION

    Energy Technology Data Exchange (ETDEWEB)

    De Sterck, H

    2011-10-18

    The following work has been performed by PI Hans De Sterck and graduate student Manda Winlaw for the required tasks 1-5 (as listed in the Statement of Work). Graduate student Manda Winlaw has visited LLNL January 31-March 11, 2011 and May 23-August 19, 2010, working with Van Henson and Mike O'Hara on non-negative matrix factorizations (NMF). She has investigated the dense subgraph clustering algorithm from 'Finding Dense Subgraphs for Sparse Undirected, Directed, and Bipartite Graphs' by Chen and Saad, testing this method on several term-document matrices and adapting it to cluster based on the rank of the subgraphs instead of the density. Manda Winlaw was awarded a first prize in the annual LLNL summer student poster competition for a poster on her NMF research. PI Hans De Sterck has developed a new adaptive algebraic multigrid algorithm for computing a few dominant or minimal singular triplets of sparse rectangular matrices. This work builds on adaptive algebraic multigrid methods that were further developed by the PI and collaborators (including Sanders and Henson) for Markov chains. The method also combines and extends existing multigrid algorithms for the symmetric eigenproblem. The PI has visited LLNL February 22-25, 2011, and has given a CASC seminar 'Algebraic Multigrid for the Singular Value Problem' on this work on February 23, 2011. During his visit, he has discussed this work and related topics with Van Henson, Geoffrey Sanders, Panayot Vassilevski, and others. He has tested the algorithm on PDE matrices and on a term-document matrix, with promising initial results. Manda Winlaw has also started to work, with O'Hara, on estimating probability distributions over undirected graph edges. The goal is to estimate probabilistic models from sets of undirected graph edges for the purpose of prediction, anomaly detection and support to supervised learning. Graduate student Manda Winlaw is writing a paper on the results obtained with

  9. 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.

  10. Tracing a planar algebraic curve

    International Nuclear Information System (INIS)

    Chen Falai; Kozak, J.

    1994-09-01

    In this paper, an algorithm that determines a real algebraic curve is outlined. Its basic step is to divide the plane into subdomains that include only simple branches of the algebraic curve without singular points. Each of the branches is then stably and efficiently traced in the particular subdomain. Except for the tracing, the algorithm requires only a couple of simple operations on polynomials that can be carried out exactly if the coefficients are rational, and the determination of zeros of several polynomials of one variable. (author). 5 refs, 4 figs

  11. Accelerating Lattice QCD Multigrid on GPUs Using Fine-Grained Parallelization

    Energy Technology Data Exchange (ETDEWEB)

    Clark, M. A. [NVIDIA Corp., Santa Clara; Joó, Bálint [Jefferson Lab; Strelchenko, Alexei [Fermilab; Cheng, Michael [Boston U., Ctr. Comp. Sci.; Gambhir, Arjun [William-Mary Coll.; Brower, Richard [Boston U.

    2016-12-22

    The past decade has witnessed a dramatic acceleration of lattice quantum chromodynamics calculations in nuclear and particle physics. This has been due to both significant progress in accelerating the iterative linear solvers using multi-grid algorithms, and due to the throughput improvements brought by GPUs. Deploying hierarchical algorithms optimally on GPUs is non-trivial owing to the lack of parallelism on the coarse grids, and as such, these advances have not proved multiplicative. Using the QUDA library, we demonstrate that by exposing all sources of parallelism that the underlying stencil problem possesses, and through appropriate mapping of this parallelism to the GPU architecture, we can achieve high efficiency even for the coarsest of grids. Results are presented for the Wilson-Clover discretization, where we demonstrate up to 10x speedup over present state-of-the-art GPU-accelerated methods on Titan. Finally, we look to the future, and consider the software implications of our findings.

  12. Annual Copper Mountain Conferences on Multigrid and Iterative Methods, Copper Mountain, Colorado

    International Nuclear Information System (INIS)

    McCormick, Stephen F.

    2016-01-01

    This project supported the Copper Mountain Conference on Multigrid and Iterative Methods, held from 2007 to 2015, at Copper Mountain, Colorado. The subject of the Copper Mountain Conference Series alternated between Multigrid Methods in odd-numbered years and Iterative Methods in even-numbered years. Begun in 1983, the Series represents an important forum for the exchange of ideas in these two closely related fields. This report describes the Copper Mountain Conference on Multigrid and Iterative Methods, 2007-2015. Information on the conference series is available at http://grandmaster.colorado.edu/~copper/

  13. Annual Copper Mountain Conferences on Multigrid and Iterative Methods, Copper Mountain, Colorado

    Energy Technology Data Exchange (ETDEWEB)

    McCormick, Stephen F. [Front Range Scientific, Inc., Lake City, CO (United States)

    2016-03-25

    This project supported the Copper Mountain Conference on Multigrid and Iterative Methods, held from 2007 to 2015, at Copper Mountain, Colorado. The subject of the Copper Mountain Conference Series alternated between Multigrid Methods in odd-numbered years and Iterative Methods in even-numbered years. Begun in 1983, the Series represents an important forum for the exchange of ideas in these two closely related fields. This report describes the Copper Mountain Conference on Multigrid and Iterative Methods, 2007-2015. Information on the conference series is available at http://grandmaster.colorado.edu/~copper/.

  14. Energy footprint of advanced dense numerical linear algebra using tile algorithms on multicore architectures

    KAUST Repository

    Dongarra, Jack

    2012-11-01

    We propose to study the impact on the energy footprint of two advanced algorithmic strategies in the context of high performance dense linear algebra libraries: (1) mixed precision algorithms with iterative refinement allow to run at the peak performance of single precision floating-point arithmetic while achieving double precision accuracy and (2) tree reduction technique exposes more parallelism when factorizing tall and skinny matrices for solving over determined systems of linear equations or calculating the singular value decomposition. Integrated within the PLASMA library using tile algorithms, which will eventually supersede the block algorithms from LAPACK, both strategies further excel in performance in the presence of a dynamic task scheduler while targeting multicore architecture. Energy consumption measurements are reported along with parallel performance numbers on a dual-socket quad-core Intel Xeon as well as a quad-socket quad-core Intel Sandy Bridge chip, both providing component-based energy monitoring at all levels of the system, through the Power Pack framework and the Running Average Power Limit model, respectively. © 2012 IEEE.

  15. Energy footprint of advanced dense numerical linear algebra using tile algorithms on multicore architectures

    KAUST Repository

    Dongarra, Jack; Ltaief, Hatem; Luszczek, Piotr R.; Weaver, Vincent M.

    2012-01-01

    We propose to study the impact on the energy footprint of two advanced algorithmic strategies in the context of high performance dense linear algebra libraries: (1) mixed precision algorithms with iterative refinement allow to run at the peak performance of single precision floating-point arithmetic while achieving double precision accuracy and (2) tree reduction technique exposes more parallelism when factorizing tall and skinny matrices for solving over determined systems of linear equations or calculating the singular value decomposition. Integrated within the PLASMA library using tile algorithms, which will eventually supersede the block algorithms from LAPACK, both strategies further excel in performance in the presence of a dynamic task scheduler while targeting multicore architecture. Energy consumption measurements are reported along with parallel performance numbers on a dual-socket quad-core Intel Xeon as well as a quad-socket quad-core Intel Sandy Bridge chip, both providing component-based energy monitoring at all levels of the system, through the Power Pack framework and the Running Average Power Limit model, respectively. © 2012 IEEE.

  16. Applied algebra codes, ciphers and discrete algorithms

    CERN Document Server

    Hardy, Darel W; Walker, Carol L

    2009-01-01

    This book attempts to show the power of algebra in a relatively simple setting.-Mathematical Reviews, 2010… The book supports learning by doing. In each section we can find many examples which clarify the mathematics introduced in the section and each section is followed by a series of exercises of which approximately half are solved in the end of the book. Additional the book comes with a CD-ROM containing an interactive version of the book powered by the computer algebra system Scientific Notebook. … the mathematics in the book are developed as needed and the focus of the book lies clearly o

  17. Computers in nonassociative rings and algebras

    CERN Document Server

    Beck, Robert E

    1977-01-01

    Computers in Nonassociative Rings and Algebras provides information pertinent to the computational aspects of nonassociative rings and algebras. This book describes the algorithmic approaches for solving problems using a computer.Organized into 10 chapters, this book begins with an overview of the concept of a symmetrized power of a group representation. This text then presents data structures and other computational methods that may be useful in the field of computational algebra. Other chapters consider several mathematical ideas, including identity processing in nonassociative algebras, str

  18. Neural multigrid for gauge theories and other disordered systems

    International Nuclear Information System (INIS)

    Baeker, M.; Kalkreuter, T.; Mack, G.; Speh, M.

    1992-09-01

    We present evidence that multigrid works for wave equations in disordered systems, e.g. in the presence of gauge fields, no matter how strong the disorder, but one needs to introduce a 'neural computations' point of view into large scale simulations: First, the system must learn how to do the simulations efficiently, then do the simulation (fast). The method can also be used to provide smooth interpolation kernels which are needed in multigrid Monte Carlo updates. (orig.)

  19. Rationality problem for algebraic tori

    CERN Document Server

    Hoshi, Akinari

    2017-01-01

    The authors give the complete stably rational classification of algebraic tori of dimensions 4 and 5 over a field k. In particular, the stably rational classification of norm one tori whose Chevalley modules are of rank 4 and 5 is given. The authors show that there exist exactly 487 (resp. 7, resp. 216) stably rational (resp. not stably but retract rational, resp. not retract rational) algebraic tori of dimension 4, and there exist exactly 3051 (resp. 25, resp. 3003) stably rational (resp. not stably but retract rational, resp. not retract rational) algebraic tori of dimension 5. The authors make a procedure to compute a flabby resolution of a G-lattice effectively by using the computer algebra system GAP. Some algorithms may determine whether the flabby class of a G-lattice is invertible (resp. zero) or not. Using the algorithms, the suthors determine all the flabby and coflabby G-lattices of rank up to 6 and verify that they are stably permutation. The authors also show that the Krull-Schmidt theorem for G-...

  20. Invariants of triangular Lie algebras

    International Nuclear Information System (INIS)

    Boyko, Vyacheslav; Patera, Jiri; Popovych, Roman

    2007-01-01

    Triangular Lie algebras are the Lie algebras which can be faithfully represented by triangular matrices of any finite size over the real/complex number field. In the paper invariants ('generalized Casimir operators') are found for three classes of Lie algebras, namely those which are either strictly or non-strictly triangular, and for so-called special upper triangular Lie algebras. Algebraic algorithm of Boyko et al (2006 J. Phys. A: Math. Gen.39 5749 (Preprint math-ph/0602046)), developed further in Boyko et al (2007 J. Phys. A: Math. Theor.40 113 (Preprint math-ph/0606045)), is used to determine the invariants. A conjecture of Tremblay and Winternitz (2001 J. Phys. A: Math. Gen.34 9085), concerning the number of independent invariants and their form, is corroborated

  1. Waterloo Workshop on Computer Algebra

    CERN Document Server

    Zima, Eugene; WWCA-2016; Advances in computer algebra : in honour of Sergei Abramov's' 70th birthday

    2018-01-01

    This book discusses the latest advances in algorithms for symbolic summation, factorization, symbolic-numeric linear algebra and linear functional equations. It presents a collection of papers on original research topics from the Waterloo Workshop on Computer Algebra (WWCA-2016), a satellite workshop of the International Symposium on Symbolic and Algebraic Computation (ISSAC’2016), which was held at Wilfrid Laurier University (Waterloo, Ontario, Canada) on July 23–24, 2016.   This workshop and the resulting book celebrate the 70th birthday of Sergei Abramov (Dorodnicyn Computing Centre of the Russian Academy of Sciences, Moscow), whose highly regarded and inspirational contributions to symbolic methods have become a crucial benchmark of computer algebra and have been broadly adopted by many Computer Algebra systems.

  2. Advanced computer algebra algorithms for the expansion of Feynman integrals

    International Nuclear Information System (INIS)

    Ablinger, Jakob; Round, Mark; Schneider, Carsten

    2012-10-01

    Two-point Feynman parameter integrals, with at most one mass and containing local operator insertions in 4+ε-dimensional Minkowski space, can be transformed to multi-integrals or multi-sums over hyperexponential and/or hypergeometric functions depending on a discrete parameter n. Given such a specific representation, we utilize an enhanced version of the multivariate Almkvist-Zeilberger algorithm (for multi-integrals) and a common summation framework of the holonomic and difference field approach (for multi-sums) to calculate recurrence relations in n. Finally, solving the recurrence we can decide efficiently if the first coefficients of the Laurent series expansion of a given Feynman integral can be expressed in terms of indefinite nested sums and products; if yes, the all n solution is returned in compact representations, i.e., no algebraic relations exist among the occurring sums and products.

  3. Advanced computer algebra algorithms for the expansion of Feynman integrals

    Energy Technology Data Exchange (ETDEWEB)

    Ablinger, Jakob; Round, Mark; Schneider, Carsten [Johannes Kepler Univ., Linz (Austria). Research Inst. for Symbolic Computation; Bluemlein, Johannes [Deutsches Elektronen-Synchrotron (DESY), Zeuthen (Germany)

    2012-10-15

    Two-point Feynman parameter integrals, with at most one mass and containing local operator insertions in 4+{epsilon}-dimensional Minkowski space, can be transformed to multi-integrals or multi-sums over hyperexponential and/or hypergeometric functions depending on a discrete parameter n. Given such a specific representation, we utilize an enhanced version of the multivariate Almkvist-Zeilberger algorithm (for multi-integrals) and a common summation framework of the holonomic and difference field approach (for multi-sums) to calculate recurrence relations in n. Finally, solving the recurrence we can decide efficiently if the first coefficients of the Laurent series expansion of a given Feynman integral can be expressed in terms of indefinite nested sums and products; if yes, the all n solution is returned in compact representations, i.e., no algebraic relations exist among the occurring sums and products.

  4. Multigrid for high dimensional elliptic partial differential equations on non-equidistant grids

    NARCIS (Netherlands)

    bin Zubair, H.; Oosterlee, C.E.; Wienands, R.

    2006-01-01

    This work presents techniques, theory and numbers for multigrid in a general d-dimensional setting. The main focus is the multigrid convergence for high-dimensional partial differential equations (PDEs). As a model problem we have chosen the anisotropic diffusion equation, on a unit hypercube. We

  5. Algorithms in Singular

    Directory of Open Access Journals (Sweden)

    Hans Schonemann

    1996-12-01

    Full Text Available Some algorithms for singularity theory and algebraic geometry The use of Grobner basis computations for treating systems of polynomial equations has become an important tool in many areas. This paper introduces of the concept of standard bases (a generalization of Grobner bases and the application to some problems from algebraic geometry. The examples are presented as SINGULAR commands. A general introduction to Grobner bases can be found in the textbook [CLO], an introduction to syzygies in [E] and [St1]. SINGULAR is a computer algebra system for computing information about singularities, for use in algebraic geometry. The basic algorithms in SINGULAR are several variants of a general standard basis algorithm for general monomial orderings (see [GG]. This includes wellorderings (Buchberger algorithm ([B1], [B2] and tangent cone orderings (Mora algorithm ([M1], [MPT] as special cases: It is able to work with non-homogeneous and homogeneous input and also to compute in the localization of the polynomial ring in 0. Recent versions include algorithms to factorize polynomials and a factorizing Grobner basis algorithm. For a complete description of SINGULAR see [Si].

  6. Multigrid solution of the convection-diffusion equation with high-Reynolds number

    Energy Technology Data Exchange (ETDEWEB)

    Zhang, Jun [George Washington Univ., Washington, DC (United States)

    1996-12-31

    A fourth-order compact finite difference scheme is employed with the multigrid technique to solve the variable coefficient convection-diffusion equation with high-Reynolds number. Scaled inter-grid transfer operators and potential on vectorization and parallelization are discussed. The high-order multigrid method is unconditionally stable and produces solution of 4th-order accuracy. Numerical experiments are included.

  7. A Parallel Algebraic Multigrid Solver on Graphics Processing Units

    KAUST Repository

    Haase, Gundolf; Liebmann, Manfred; Douglas, Craig C.; Plank, Gernot

    2010-01-01

    -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

  8. Development of a multi-grid FDTD code for three-dimensional simulation of large microwave sintering experiments

    Energy Technology Data Exchange (ETDEWEB)

    White, M.J.; Iskander, M.F. [Univ. of Utah, Salt Lake City, UT (United States). Electrical Engineering Dept.; Kimrey, H.D. [Oak Ridge National Lab., TN (United States)

    1996-12-31

    The Finite-Difference Time-Domain (FDTD) code available at the University of Utah has been used to simulate sintering of ceramics in single and multimode cavities, and many useful results have been reported in literature. More detailed and accurate results, specifically around and including the ceramic sample, are often desired to help evaluate the adequacy of the heating procedure. In electrically large multimode cavities, however, computer memory requirements limit the number of the mathematical cells, and the desired resolution is impractical to achieve due to limited computer resources. Therefore, an FDTD algorithm which incorporates multiple-grid regions with variable-grid sizes is required to adequately perform the desired simulations. In this paper the authors describe the development of a three-dimensional multi-grid FDTD code to help focus a large number of cells around the desired region. Test geometries were solved using a uniform-grid and the developed multi-grid code to help validate the results from the developed code. Results from these comparisons, as well as the results of comparisons between the developed FDTD code and other available variable-grid codes are presented. In addition, results from the simulation of realistic microwave sintering experiments showed improved resolution in critical sites inside the three-dimensional sintering cavity. With the validation of the FDTD code, simulations were performed for electrically large, multimode, microwave sintering cavities to fully demonstrate the advantages of the developed multi-grid FDTD code.

  9. Algorithms for finding Chomsky and Greibach normal forms for a fuzzy context-free grammar using an algebraic approach

    Energy Technology Data Exchange (ETDEWEB)

    Lee, E.T.

    1983-01-01

    Algorithms for the construction of the Chomsky and Greibach normal forms for a fuzzy context-free grammar using the algebraic approach are presented and illustrated by examples. The results obtained in this paper may have useful applications in fuzzy languages, pattern recognition, information storage and retrieval, artificial intelligence, database and pictorial information systems. 16 references.

  10. Circle Maps and C*-algebras

    DEFF Research Database (Denmark)

    Schmidt, Thomas Lundsgaard; Thomsen, Klaus

    2015-01-01

    We consider a construction of $C^*$-algebras from continuous piecewise monotone maps on the circle which generalizes the crossed product construction for homeomorphisms and more generally the construction of Renault, Deaconu and Anantharaman-Delaroche for local homeomorphisms. Assuming that the map...... is surjective and not locally injective we give necessary and sufficient conditions for the simplicity of the $C^*$-algebra and show that it is then a Kirchberg algebra. We provide tools for the calculation of the K-theory groups and turn them into an algorithmic method for Markov maps....

  11. Multigrid solution of incompressible turbulent flows by using two-equation turbulence models

    Energy Technology Data Exchange (ETDEWEB)

    Zheng, X.; Liu, C. [Front Range Scientific Computations, Inc., Denver, CO (United States); Sung, C.H. [David Taylor Model Basin, Bethesda, MD (United States)

    1996-12-31

    Most of practical flows are turbulent. From the interest of engineering applications, simulation of realistic flows is usually done through solution of Reynolds-averaged Navier-Stokes equations and turbulence model equations. It has been widely accepted that turbulence modeling plays a very important role in numerical simulation of practical flow problem, particularly when the accuracy is of great concern. Among the most used turbulence models today, two-equation models appear to be favored for the reason that they are more general than algebraic models and affordable with current available computer resources. However, investigators using two-equation models seem to have been more concerned with the solution of N-S equations. Less attention is paid to the solution method for the turbulence model equations. In most cases, the turbulence model equations are loosely coupled with N-S equations, multigrid acceleration is only applied to the solution of N-S equations due to perhaps the fact the turbulence model equations are source-term dominant and very stiff in sublayer region.

  12. Profiling high performance dense linear algebra algorithms on multicore architectures for power and energy efficiency

    KAUST Repository

    Ltaief, Hatem

    2011-08-31

    This paper presents the power profile of two high performance dense linear algebra libraries i.e., LAPACK and PLASMA. The former is based on block algorithms that use the fork-join paradigm to achieve parallel performance. The latter uses fine-grained task parallelism that recasts the computation to operate on submatrices called tiles. In this way tile algorithms are formed. We show results from the power profiling of the most common routines, which permits us to clearly identify the different phases of the computations. This allows us to isolate the bottlenecks in terms of energy efficiency. Our results show that PLASMA surpasses LAPACK not only in terms of performance but also in terms of energy efficiency. © 2011 Springer-Verlag.

  13. Commutative algebra constructive methods finite projective modules

    CERN Document Server

    Lombardi, Henri

    2015-01-01

    Translated from the popular French edition, this book offers a detailed introduction to various basic concepts, methods, principles, and results of commutative algebra. It takes a constructive viewpoint in commutative algebra and studies algorithmic approaches alongside several abstract classical theories. Indeed, it revisits these traditional topics with a new and simplifying manner, making the subject both accessible and innovative. The algorithmic aspects of such naturally abstract topics as Galois theory, Dedekind rings, Prüfer rings, finitely generated projective modules, dimension theory of commutative rings, and others in the current treatise, are all analysed in the spirit of the great developers of constructive algebra in the nineteenth century. This updated and revised edition contains over 350 well-arranged exercises, together with their helpful hints for solution. A basic knowledge of linear algebra, group theory, elementary number theory as well as the fundamentals of ring and module theory is r...

  14. s-Step Krylov Subspace Methods as Bottom Solvers for Geometric Multigrid

    Energy Technology Data Exchange (ETDEWEB)

    Williams, Samuel [Lawrence Berkeley National Lab. (LBNL), Berkeley, CA (United States); Lijewski, Mike [Lawrence Berkeley National Lab. (LBNL), Berkeley, CA (United States); Almgren, Ann [Lawrence Berkeley National Lab. (LBNL), Berkeley, CA (United States); Straalen, Brian Van [Lawrence Berkeley National Lab. (LBNL), Berkeley, CA (United States); Carson, Erin [Univ. of California, Berkeley, CA (United States); Knight, Nicholas [Univ. of California, Berkeley, CA (United States); Demmel, James [Univ. of California, Berkeley, CA (United States)

    2014-08-14

    Geometric multigrid solvers within adaptive mesh refinement (AMR) applications often reach a point where further coarsening of the grid becomes impractical as individual sub domain sizes approach unity. At this point the most common solution is to use a bottom solver, such as BiCGStab, to reduce the residual by a fixed factor at the coarsest level. Each iteration of BiCGStab requires multiple global reductions (MPI collectives). As the number of BiCGStab iterations required for convergence grows with problem size, and the time for each collective operation increases with machine scale, bottom solves in large-scale applications can constitute a significant fraction of the overall multigrid solve time. In this paper, we implement, evaluate, and optimize a communication-avoiding s-step formulation of BiCGStab (CABiCGStab for short) as a high-performance, distributed-memory bottom solver for geometric multigrid solvers. This is the first time s-step Krylov subspace methods have been leveraged to improve multigrid bottom solver performance. We use a synthetic benchmark for detailed analysis and integrate the best implementation into BoxLib in order to evaluate the benefit of a s-step Krylov subspace method on the multigrid solves found in the applications LMC and Nyx on up to 32,768 cores on the Cray XE6 at NERSC. Overall, we see bottom solver improvements of up to 4.2x on synthetic problems and up to 2.7x in real applications. This results in as much as a 1.5x improvement in solver performance in real applications.

  15. Multigrid techniques for nonlinear eigenvalue probems: Solutions of a nonlinear Schroedinger eigenvalue problem in 2D and 3D

    Science.gov (United States)

    Costiner, Sorin; Taasan, Shlomo

    1994-01-01

    This paper presents multigrid (MG) techniques for nonlinear eigenvalue problems (EP) and emphasizes an MG algorithm for a nonlinear Schrodinger EP. The algorithm overcomes the mentioned difficulties combining the following techniques: an MG projection coupled with backrotations for separation of solutions and treatment of difficulties related to clusters of close and equal eigenvalues; MG subspace continuation techniques for treatment of the nonlinearity; an MG simultaneous treatment of the eigenvectors at the same time with the nonlinearity and with the global constraints. The simultaneous MG techniques reduce the large number of self consistent iterations to only a few or one MG simultaneous iteration and keep the solutions in a right neighborhood where the algorithm converges fast.

  16. The multigrid method for reactor calculations

    International Nuclear Information System (INIS)

    Douglas, S.R.

    1991-07-01

    Iterative solutions to linear systems of equations are discussed. The emphasis is on the concepts that affect convergence rates of these solution methods. The multigrid method is described, including the smoothing property, restriction, and prolongation. A simple example is used to illustrate the ideas

  17. Multi-grid Particle-in-cell Simulations of Plasma Microturbulence

    International Nuclear Information System (INIS)

    Lewandowski, J.L.V.

    2003-01-01

    A new scheme to accurately retain kinetic electron effects in particle-in-cell (PIC) simulations for the case of electrostatic drift waves is presented. The splitting scheme, which is based on exact separation between adiabatic and on adiabatic electron responses, is shown to yield more accurate linear growth rates than the standard df scheme. The linear and nonlinear elliptic problems that arise in the splitting scheme are solved using a multi-grid solver. The multi-grid particle-in-cell approach offers an attractive path, both from the physics and numerical points of view, to simulate kinetic electron dynamics in global toroidal plasmas

  18. Recent results in the decoding of Algebraic geometry codes

    DEFF Research Database (Denmark)

    Høholdt, Tom; Jensen, Helge Elbrønd; Nielsen, Rasmus Refslund

    1998-01-01

    We analyse the known decoding algorithms for algebraic geometry codes in the case where the number of errors is [(dFR-1)/2]+1, where dFR is the Feng-Rao distance......We analyse the known decoding algorithms for algebraic geometry codes in the case where the number of errors is [(dFR-1)/2]+1, where dFR is the Feng-Rao distance...

  19. Fast Bitwise Implementation of the Algebraic Normal Form Transform

    OpenAIRE

    Bakoev, Valentin

    2017-01-01

    The representation of Boolean functions by their algebraic normal forms (ANFs) is very important for cryptography, coding theory and other scientific areas. The ANFs are used in computing the algebraic degree of S-boxes, some other cryptographic criteria and parameters of errorcorrecting codes. Their applications require these criteria and parameters to be computed by fast algorithms. Hence the corresponding ANFs should also be obtained by fast algorithms. Here we continue o...

  20. Multigrid methods for S/sub N/ problems

    International Nuclear Information System (INIS)

    Nowak, P.F.; Larsen, E.W.; Martin, W.R.

    1987-01-01

    It has long been known that the standard source iteration (SI) method for obtaining iterative solutions of S/sub N/ problems is very slowly converging in optically thick regions with low absorption. The rebalance and diffusion synthetic acceleration (DSA) methods are generalizations of SI that have been developed to accelerate convergence, but neither of these methods has been completely successful. In particular, the rebalance method tends to become unstable in problems where it is needed most (problems with high scattering ratios c = 1), while the DSA method, to be implemented in a stable fashion, requires the solution of a particular system of acceleration equations, and this has been done efficiently in two-dimensional geometries only for the diamond difference S/sub N/ equations. This paper discusses another extension of the SI method, namely, SI combined with the spatial multigrid algorithm (SIMG). This appears to be a viable way to accelerate many S/sub N/ problems in multidimensional geometries, provided the finest mesh consists of cells that are not optically thick

  1. Solution of systems of linear algebraic equations by the method of summation of divergent series

    International Nuclear Information System (INIS)

    Kirichenko, G.A.; Korovin, Ya.S.; Khisamutdinov, M.V.; Shmojlov, V.I.

    2015-01-01

    A method for solving systems of linear algebraic equations has been proposed on the basis on the summation of the corresponding continued fractions. The proposed algorithm for solving systems of linear algebraic equations is classified as direct algorithms providing an exact solution in a finite number of operations. Examples of solving systems of linear algebraic equations have been presented and the effectiveness of the algorithm has been estimated [ru

  2. Numerical linear algebra a concise introduction with Matlab and Julia

    CERN Document Server

    Bornemann, Folkmar

    2018-01-01

    This book offers an introduction to the algorithmic-numerical thinking using basic problems of linear algebra. By focusing on linear algebra, it ensures a stronger thematic coherence than is otherwise found in introductory lectures on numerics. The book highlights the usefulness of matrix partitioning compared to a component view, leading not only to a clearer notation and shorter algorithms, but also to significant runtime gains in modern computer architectures. The algorithms and accompanying numerical examples are given in the programming environment MATLAB, and additionally – in an appendix – in the future-oriented, freely accessible programming language Julia. This book is suitable for a two-hour lecture on numerical linear algebra from the second semester of a bachelor's degree in mathematics.

  3. Uzawa smoother in multigrid for the coupleD porous medium and stokes flow system

    NARCIS (Netherlands)

    P. Luo (Peiyao); C. Rodrigo (Carmen); F.J. Gaspar Lorenz (Franscisco); C.W. Oosterlee (Kees)

    2017-01-01

    textabstractThe multigrid solution of coupled porous media and Stokes flow problems is considered. The Darcy equation as the saturated porous medium model is coupled to the Stokes equations by means of appropriate interface conditions. We focus on an efficient multigrid solution technique for the

  4. Rigorous lower bound on the dynamic critical exponent of some multilevel Swendsen-Wang algorithms

    International Nuclear Information System (INIS)

    Li, X.; Sokal, A.D.

    1991-01-01

    We prove the rigorous lower bound z exp ≥α/ν for the dynamic critical exponent of a broad class of multilevel (or ''multigrid'') variants of the Swendsen-Wang algorithm. This proves that such algorithms do suffer from critical slowing down. We conjecture that such algorithms in fact lie in the same dynamic universality class as the stanard Swendsen-Wang algorithm

  5. Constructing canonical bases of quantized enveloping algebras

    OpenAIRE

    Graaf, W.A. de

    2001-01-01

    An algorithm for computing the elements of a given weight of the canonical basis of a quantized enveloping algebra is described. Subsequently, a similar algorithm is presented for computing the canonical basis of a finite-dimensional module.

  6. Numerical linear algebra with applications using Matlab

    CERN Document Server

    Ford, William

    2014-01-01

    Designed for those who want to gain a practical knowledge of modern computational techniques for the numerical solution of linear algebra problems, Numerical Linear Algebra with Applications contains all the material necessary for a first year graduate or advanced undergraduate course on numerical linear algebra with numerous applications to engineering and science. With a unified presentation of computation, basic algorithm analysis, and numerical methods to compute solutions, this book is ideal for solving real-world problems. It provides necessary mathematical background information for

  7. Efficient multigrid computation of steady hypersonic flows

    NARCIS (Netherlands)

    Koren, B.; Hemker, P.W.; Murthy, T.K.S.

    1991-01-01

    In steady hypersonic flow computations, Newton iteration as a local relaxation procedure and nonlinear multigrid iteration as an acceleration procedure may both easily fail. In the present chapter, same remedies are presented for overcoming these problems. The equations considered are the steady,

  8. High performance linear algebra algorithms: An introduction

    DEFF Research Database (Denmark)

    Gustavson, F.G.; Wasniewski, Jerzy

    2006-01-01

    his Mini-Symposium consisted of two back to back sessions, each consisting of five presentations, held on the afternoon of Monday, June 21, 2004. A major theme of both sessions was novel data structures for the matrices of dense linear algebra, DLA. Talks one to four of session one all centered...

  9. Scalable smoothing strategies for a geometric multigrid method for the immersed boundary equations

    Energy Technology Data Exchange (ETDEWEB)

    Bhalla, Amneet Pal Singh [Univ. of North Carolina, Chapel Hill, NC (United States); Knepley, Matthew G. [Rice Univ., Houston, TX (United States); Adams, Mark F. [Lawrence Berkeley National Lab. (LBNL), Berkeley, CA (United States); Guy, Robert D. [Univ. of California, Davis, CA (United States); Griffith, Boyce E. [Univ. of North Carolina, Chapel Hill, NC (United States)

    2016-12-20

    The immersed boundary (IB) method is a widely used approach to simulating fluid-structure interaction (FSI). Although explicit versions of the IB method can suffer from severe time step size restrictions, these methods remain popular because of their simplicity and generality. In prior work (Guy et al., Adv Comput Math, 2015), some of us developed a geometric multigrid preconditioner for a stable semi-implicit IB method under Stokes flow conditions; however, this solver methodology used a Vanka-type smoother that presented limited opportunities for parallelization. This work extends this Stokes-IB solver methodology by developing smoothing techniques that are suitable for parallel implementation. Specifically, we demonstrate that an additive version of the Vanka smoother can yield an effective multigrid preconditioner for the Stokes-IB equations, and we introduce an efficient Schur complement-based smoother that is also shown to be effective for the Stokes-IB equations. We investigate the performance of these solvers for a broad range of material stiffnesses, both for Stokes flows and flows at nonzero Reynolds numbers, and for thick and thin structural models. We show here that linear solver performance degrades with increasing Reynolds number and material stiffness, especially for thin interface cases. Nonetheless, the proposed approaches promise to yield effective solution algorithms, especially at lower Reynolds numbers and at modest-to-high elastic stiffnesses.

  10. A faithful functor among algebras and graphs

    OpenAIRE

    Falcón Ganfornina, Óscar Jesús; Falcón Ganfornina, Raúl Manuel; Núñez Valdés, Juan; Pacheco Martínez, Ana María; Villar Liñán, María Trinidad; Vigo Aguiar, Jesús (Coordinador)

    2016-01-01

    The problem of identifying a functor between the categories of algebras and graphs is currently open. Based on a known algorithm that identifies isomorphisms of Latin squares with isomorphism of vertex-colored graphs, we describe here a pair of graphs that enable us to find a faithful functor between finite-dimensional algebras over finite fields and these graphs.

  11. On multigrid-CG for efficient topology optimization

    DEFF Research Database (Denmark)

    Amir, Oded; Aage, Niels; Lazarov, Boyan Stefanov

    2014-01-01

    reduction is obtained by exploiting specific characteristics of a multigrid preconditioned conjugate gradients (MGCG) solver. In particular, the number of MGCG iterations is reduced by relating it to the geometric parameters of the problem. At the same time, accurate outcome of the optimization process...

  12. Numerical algebra, matrix theory, differential-algebraic equations and control theory festschrift in honor of Volker Mehrmann

    CERN Document Server

    Bollhöfer, Matthias; Kressner, Daniel; Mehl, Christian; Stykel, Tatjana

    2015-01-01

    This edited volume highlights the scientific contributions of Volker Mehrmann, a leading expert in the area of numerical (linear) algebra, matrix theory, differential-algebraic equations and control theory. These mathematical research areas are strongly related and often occur in the same real-world applications. The main areas where such applications emerge are computational engineering and sciences, but increasingly also social sciences and economics. This book also reflects some of Volker Mehrmann's major career stages. Starting out working in the areas of numerical linear algebra (his first full professorship at TU Chemnitz was in "Numerical Algebra," hence the title of the book) and matrix theory, Volker Mehrmann has made significant contributions to these areas ever since. The highlights of these are discussed in Parts I and II of the present book. Often the development of new algorithms in numerical linear algebra is motivated by problems in system and control theory. These and his later major work on ...

  13. An algebraic approach to the scattering equations

    Energy Technology Data Exchange (ETDEWEB)

    Huang, Rijun; Rao, Junjie [Zhejiang Institute of Modern Physics, Zhejiang University,Hangzhou, 310027 (China); Feng, Bo [Zhejiang Institute of Modern Physics, Zhejiang University,Hangzhou, 310027 (China); Center of Mathematical Science, Zhejiang University,Hangzhou, 310027 (China); He, Yang-Hui [School of Physics, NanKai University,Tianjin, 300071 (China); Department of Mathematics, City University,London, EC1V 0HB (United Kingdom); Merton College, University of Oxford,Oxford, OX14JD (United Kingdom)

    2015-12-10

    We employ the so-called companion matrix method from computational algebraic geometry, tailored for zero-dimensional ideals, to study the scattering equations. The method renders the CHY-integrand of scattering amplitudes computable using simple linear algebra and is amenable to an algorithmic approach. Certain identities in the amplitudes as well as rationality of the final integrand become immediate in this formalism.

  14. An algebraic approach to the scattering equations

    International Nuclear Information System (INIS)

    Huang, Rijun; Rao, Junjie; Feng, Bo; He, Yang-Hui

    2015-01-01

    We employ the so-called companion matrix method from computational algebraic geometry, tailored for zero-dimensional ideals, to study the scattering equations. The method renders the CHY-integrand of scattering amplitudes computable using simple linear algebra and is amenable to an algorithmic approach. Certain identities in the amplitudes as well as rationality of the final integrand become immediate in this formalism.

  15. Computational linear and commutative algebra

    CERN Document Server

    Kreuzer, Martin

    2016-01-01

    This book combines, in a novel and general way, an extensive development of the theory of families of commuting matrices with applications to zero-dimensional commutative rings, primary decompositions and polynomial system solving. It integrates the Linear Algebra of the Third Millennium, developed exclusively here, with classical algorithmic and algebraic techniques. Even the experienced reader will be pleasantly surprised to discover new and unexpected aspects in a variety of subjects including eigenvalues and eigenspaces of linear maps, joint eigenspaces of commuting families of endomorphisms, multiplication maps of zero-dimensional affine algebras, computation of primary decompositions and maximal ideals, and solution of polynomial systems. This book completes a trilogy initiated by the uncharacteristically witty books Computational Commutative Algebra 1 and 2 by the same authors. The material treated here is not available in book form, and much of it is not available at all. The authors continue to prese...

  16. Morphing Wing Structural Optimization Using Opposite-Based Population-Based Incremental Learning and Multigrid Ground Elements

    Directory of Open Access Journals (Sweden)

    S. Sleesongsom

    2015-01-01

    Full Text Available This paper has twin aims. Firstly, a multigrid design approach for optimization of an unconventional morphing wing is proposed. The structural design problem is assigned to optimize wing mass, lift effectiveness, and buckling factor subject to structural safety requirements. Design variables consist of partial topology, nodal positions, and component sizes of a wing internal structure. Such a design process can be accomplished by using multiple resolutions of ground elements, which is called a multigrid approach. Secondly, an opposite-based multiobjective population-based incremental learning (OMPBIL is proposed for comparison with the original multiobjective population-based incremental learning (MPBIL. Multiobjective design problems with single-grid and multigrid design variables are then posed and tackled by OMPBIL and MPBIL. The results show that using OMPBIL in combination with a multigrid design approach is the best design strategy. OMPBIL is superior to MPBIL since the former provides better population diversity. Aeroelastic trim for an elastic morphing wing is also presented.

  17. Gauss Elimination: Workhorse of Linear Algebra.

    Science.gov (United States)

    1995-08-05

    linear algebra computation for solving systems, computing determinants and determining the rank of matrix. All of these are discussed in varying contexts. These include different arithmetic or algebraic setting such as integer arithmetic or polynomial rings as well as conventional real (floating-point) arithmetic. These have effects on both accuracy and complexity analyses of the algorithm. These, too, are covered here. The impact of modern parallel computer architecture on GE is also

  18. Summary of the CSRI Workshop on Combinatorial Algebraic Topology (CAT): Software, Applications, & Algorithms

    Energy Technology Data Exchange (ETDEWEB)

    Bennett, Janine Camille [Sandia National Lab. (SNL-CA), Livermore, CA (United States). Visualization and Scientific Computing Dept.; Day, David Minot [Sandia National Lab. (SNL-NM), Albuquerque, NM (United States). Applied Mathematics and Applications Dept.; Mitchell, Scott A. [Sandia National Lab. (SNL-NM), Albuquerque, NM (United States). Computer Science and Informatics Dept.

    2009-11-20

    This report summarizes the Combinatorial Algebraic Topology: software, applications & algorithms workshop (CAT Workshop). The workshop was sponsored by the Computer Science Research Institute of Sandia National Laboratories. It was organized by CSRI staff members Scott Mitchell and Shawn Martin. It was held in Santa Fe, New Mexico, August 29-30. The CAT Workshop website has links to some of the talk slides and other information, http://www.cs.sandia.gov/CSRI/Workshops/2009/CAT/index.html. The purpose of the report is to summarize the discussions and recap the sessions. There is a special emphasis on technical areas that are ripe for further exploration, and the plans for follow-up amongst the workshop participants. The intended audiences are the workshop participants, other researchers in the area, and the workshop sponsors.

  19. Some nonlinear space decomposition algorithms

    Energy Technology Data Exchange (ETDEWEB)

    Tai, Xue-Cheng; Espedal, M. [Univ. of Bergen (Norway)

    1996-12-31

    Convergence of a space decomposition method is proved for a general convex programming problem. The space decomposition refers to methods that decompose a space into sums of subspaces, which could be a domain decomposition or a multigrid method for partial differential equations. Two algorithms are proposed. Both can be used for linear as well as nonlinear elliptic problems and they reduce to the standard additive and multiplicative Schwarz methods for linear elliptic problems. Two {open_quotes}hybrid{close_quotes} algorithms are also presented. They converge faster than the additive one and have better parallelism than the multiplicative method. Numerical tests with a two level domain decomposition for linear, nonlinear and interface elliptic problems are presented for the proposed algorithms.

  20. Vertex algebras and algebraic curves

    CERN Document Server

    Frenkel, Edward

    2004-01-01

    Vertex algebras are algebraic objects that encapsulate the concept of operator product expansion from two-dimensional conformal field theory. Vertex algebras are fast becoming ubiquitous in many areas of modern mathematics, with applications to representation theory, algebraic geometry, the theory of finite groups, modular functions, topology, integrable systems, and combinatorics. This book is an introduction to the theory of vertex algebras with a particular emphasis on the relationship with the geometry of algebraic curves. The notion of a vertex algebra is introduced in a coordinate-independent way, so that vertex operators become well defined on arbitrary smooth algebraic curves, possibly equipped with additional data, such as a vector bundle. Vertex algebras then appear as the algebraic objects encoding the geometric structure of various moduli spaces associated with algebraic curves. Therefore they may be used to give a geometric interpretation of various questions of representation theory. The book co...

  1. Algebraic partial Boolean algebras

    International Nuclear Information System (INIS)

    Smith, Derek

    2003-01-01

    Partial Boolean algebras, first studied by Kochen and Specker in the 1960s, provide the structure for Bell-Kochen-Specker theorems which deny the existence of non-contextual hidden variable theories. In this paper, we study partial Boolean algebras which are 'algebraic' in the sense that their elements have coordinates in an algebraic number field. Several of these algebras have been discussed recently in a debate on the validity of Bell-Kochen-Specker theorems in the context of finite precision measurements. The main result of this paper is that every algebraic finitely-generated partial Boolean algebra B(T) is finite when the underlying space H is three-dimensional, answering a question of Kochen and showing that Conway and Kochen's infinite algebraic partial Boolean algebra has minimum dimension. This result contrasts the existence of an infinite (non-algebraic) B(T) generated by eight elements in an abstract orthomodular lattice of height 3. We then initiate a study of higher-dimensional algebraic partial Boolean algebras. First, we describe a restriction on the determinants of the elements of B(T) that are generated by a given set T. We then show that when the generating set T consists of the rays spanning the minimal vectors in a real irreducible root lattice, B(T) is infinite just if that root lattice has an A 5 sublattice. Finally, we characterize the rays of B(T) when T consists of the rays spanning the minimal vectors of the root lattice E 8

  2. Algebraic classification of the conformal tensor

    International Nuclear Information System (INIS)

    Ares de Parga, Gonzalo; Chavoya, O.; Lopez B, J.L.; Ovando Z, Gerardo

    1989-01-01

    Starting from the Petrov matrix method, we deduce a new algorithm (adaptable to computers), within the Newman-Penrose formalism, to obtain the algebraic type of the Weyl tensor in general relativity. (author)

  3. Symbolic Reachability for Process Algebras with Recursive Data Types

    NARCIS (Netherlands)

    Blom, Stefan; van de Pol, Jan Cornelis; Fitzgerald, J.S.; Haxthausen, A.E.; Yenigun, H.

    2008-01-01

    In this paper, we present a symbolic reachability algorithm for process algebras with recursive data types. Like the various saturation based algorithms of Ciardo et al, the algorithm is based on partitioning of the transition relation into events whose influence is local. As new features, our

  4. Forward error correction based on algebraic-geometric theory

    CERN Document Server

    A Alzubi, Jafar; M Chen, Thomas

    2014-01-01

    This book covers the design, construction, and implementation of algebraic-geometric codes from Hermitian curves. Matlab simulations of algebraic-geometric codes and Reed-Solomon codes compare their bit error rate using different modulation schemes over additive white Gaussian noise channel model. Simulation results of Algebraic-geometric codes bit error rate performance using quadrature amplitude modulation (16QAM and 64QAM) are presented for the first time and shown to outperform Reed-Solomon codes at various code rates and channel models. The book proposes algebraic-geometric block turbo codes. It also presents simulation results that show an improved bit error rate performance at the cost of high system complexity due to using algebraic-geometric codes and Chase-Pyndiah’s algorithm simultaneously. The book proposes algebraic-geometric irregular block turbo codes (AG-IBTC) to reduce system complexity. Simulation results for AG-IBTCs are presented for the first time.

  5. Numerical Evaluation of P-Multigrid Method for the Solution of Discontinuous Galerkin Discretizations of Diffusive Equations

    Science.gov (United States)

    Atkins, H. L.; Helenbrook, B. T.

    2005-01-01

    This paper describes numerical experiments with P-multigrid to corroborate analysis, validate the present implementation, and to examine issues that arise in the implementations of the various combinations of relaxation schemes, discretizations and P-multigrid methods. The two approaches to implement P-multigrid presented here are equivalent for most high-order discretization methods such as spectral element, SUPG, and discontinuous Galerkin applied to advection; however it is discovered that the approach that mimics the common geometric multigrid implementation is less robust, and frequently unstable when applied to discontinuous Galerkin discretizations of di usion. Gauss-Seidel relaxation converges 40% faster than block Jacobi, as predicted by analysis; however, the implementation of Gauss-Seidel is considerably more expensive that one would expect because gradients in most neighboring elements must be updated. A compromise quasi Gauss-Seidel relaxation method that evaluates the gradient in each element twice per iteration converges at rates similar to those predicted for true Gauss-Seidel.

  6. Applied linear algebra and matrix analysis

    CERN Document Server

    Shores, Thomas S

    2018-01-01

    In its second edition, this textbook offers a fresh approach to matrix and linear algebra. Its blend of theory, computational exercises, and analytical writing projects is designed to highlight the interplay between these aspects of an application. This approach places special emphasis on linear algebra as an experimental science that provides tools for solving concrete problems. The second edition’s revised text discusses applications of linear algebra like graph theory and network modeling methods used in Google’s PageRank algorithm. Other new materials include modeling examples of diffusive processes, linear programming, image processing, digital signal processing, and Fourier analysis. These topics are woven into the core material of Gaussian elimination and other matrix operations; eigenvalues, eigenvectors, and discrete dynamical systems; and the geometrical aspects of vector spaces. Intended for a one-semester undergraduate course without a strict calculus prerequisite, Applied Linear Algebra and M...

  7. Linear Algebra and Smarandache Linear Algebra

    OpenAIRE

    Vasantha, Kandasamy

    2003-01-01

    The present book, on Smarandache linear algebra, not only studies the Smarandache analogues of linear algebra and its applications, it also aims to bridge the need for new research topics pertaining to linear algebra, purely in the algebraic sense. We have introduced Smarandache semilinear algebra, Smarandache bilinear algebra and Smarandache anti-linear algebra and their fuzzy equivalents. Moreover, in this book, we have brought out the study of linear algebra and vector spaces over finite p...

  8. 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.

  9. Analysis of an aggregation-based algebraic two-grid method for a rotated anisotropic diffusion problem

    KAUST Repository

    Chen, Meng-Huo; Greenbaum, Anne

    2015-01-01

    Summary: A two-grid convergence analysis based on the paper [Algebraic analysis of aggregation-based multigrid, by A. Napov and Y. Notay, Numer. Lin. Alg. Appl. 18 (2011), pp. 539-564] is derived for various aggregation schemes applied to a finite element discretization of a rotated anisotropic diffusion equation. As expected, it is shown that the best aggregation scheme is one in which aggregates are aligned with the anisotropy. In practice, however, this is not what automatic aggregation procedures do. We suggest approaches for determining appropriate aggregates based on eigenvectors associated with small eigenvalues of a block splitting matrix or based on minimizing a quantity related to the spectral radius of the iteration matrix. © 2015 John Wiley & Sons, Ltd.

  10. Analysis of an aggregation-based algebraic two-grid method for a rotated anisotropic diffusion problem

    KAUST Repository

    Chen, Meng-Huo

    2015-03-18

    Summary: A two-grid convergence analysis based on the paper [Algebraic analysis of aggregation-based multigrid, by A. Napov and Y. Notay, Numer. Lin. Alg. Appl. 18 (2011), pp. 539-564] is derived for various aggregation schemes applied to a finite element discretization of a rotated anisotropic diffusion equation. As expected, it is shown that the best aggregation scheme is one in which aggregates are aligned with the anisotropy. In practice, however, this is not what automatic aggregation procedures do. We suggest approaches for determining appropriate aggregates based on eigenvectors associated with small eigenvalues of a block splitting matrix or based on minimizing a quantity related to the spectral radius of the iteration matrix. © 2015 John Wiley & Sons, Ltd.

  11. Introduction to vertex algebras, Borcherds algebras and the Monster Lie algebras

    International Nuclear Information System (INIS)

    Gebert, R.W.

    1993-09-01

    The theory of vertex algebras constitutes a mathematically rigorous axiomatic formulation of the algebraic origins of conformal field theory. In this context Borcherds algebras arise as certain ''physical'' subspaces of vertex algebras. The aim of this review is to give a pedagogical introduction into this rapidly-developing area of mathematics. Based on the machinery of formal calculus we present the axiomatic definition of vertex algebras. We discuss the connection with conformal field theory by deriving important implications of these axioms. In particular, many explicit calculations are presented to stress the eminent role of the Jacobi identity axiom for vertex algebras. As a class of concrete examples the vertex algebras associated with even lattices are constructed and it is shown in detail how affine Lie algebras and the fake Monster Lie algebra naturally appear. This leads us to the abstract definition of Borcherds algebras as generalized Kac-Moody algebras and their basic properties. Finally, the results about the simplest generic Borcherds algebras are analysed from the point of view of symmetry in quantum theory and the construction of the Monster Lie algebra is sketched. (orig.)

  12. Towards a multigrid scheme in SU(2) lattice gauge theory

    International Nuclear Information System (INIS)

    Gutbrod, F.

    1992-12-01

    The task of constructing a viable updating multigrid scheme for SU(2) lattice gauge theory is discussed in connection with the classical eigenvalue problem. For a nonlocal overrelaxation Monte Carlo update step, the central numerical problem is the search for the minimum of a quadratic approximation to the action under nonlocal constraints. Here approximate eigenfunctions are essential to reduce the numerical work, and these eigenfunctions are to be constructed with multigrid techniques. A simple implementation on asymmetric lattices is described, where the grids are restricted to 3-dimensional hyperplanes. The scheme is shown to be moderately successful in the early stages of the updating history (starting from a cold configuration). The main results of another, less asymmetric scheme are presented briefly. (orig.)

  13. The finite volume element (FVE) and multigrid method for the incompressible Navier-Stokes equations

    International Nuclear Information System (INIS)

    Gu Lizhen; Bao Weizhu

    1992-01-01

    The authors apply FVE method to discrete INS equations with the original variable, in which the bilinear square finite element and the square finite volume are chosen. The discrete schemes of INS equations are presented. The FMV multigrid algorithm is applied to solve that discrete system, where DGS iteration is used as smoother, DGS distributive mode for the INS discrete system is also presented. The sample problems for the square cavity flow with Reynolds number Re≤100 are successfully calculated. The numerical solutions show that the results with 1 FMV is satisfactory and when Re is not large, The FVE discrete scheme of the conservative INS equations and that of non-conservative INS equations with linearization both can provide almost same accuracy

  14. Algorithmic Verification of Linearizability for Ordinary Differential Equations

    KAUST Repository

    Lyakhov, Dmitry A.; Gerdt, Vladimir P.; Michels, Dominik L.

    2017-01-01

    one by a point transformation of the dependent and independent variables. The first algorithm is based on a construction of the Lie point symmetry algebra and on the computation of its derived algebra. The second algorithm exploits the differential

  15. A program for constructing finitely presented Lie algebras and superalgebras

    International Nuclear Information System (INIS)

    Gerdt, V.P.; Kornyak, V.V.

    1997-01-01

    The purpose of this paper is to describe a C program FPLSA for investigating finitely presented Lie algebras and superalgebras. The underlying algorithm is based on constructing the complete set of relations called also standard basis or Groebner basis of ideal of free Lie (super) algebra generated by the input set of relations. The program may be used, in particular, to compute the Lie (super)algebra basis elements and its structure constants, to classify the finitely presented algebras depending on the values of parameters in the relations, and to construct the Hilbert series. These problems are illustrated by examples. (orig.)

  16. A Multigrid NLS-4DVar Data Assimilation Scheme with Advanced Research WRF (ARW)

    Science.gov (United States)

    Zhang, H.; Tian, X.

    2017-12-01

    The motions of the atmosphere have multiscale properties in space and/or time, and the background error covariance matrix (Β) should thus contain error information at different correlation scales. To obtain an optimal analysis, the multigrid three-dimensional variational data assimilation scheme is used widely when sequentially correcting errors from large to small scales. However, introduction of the multigrid technique into four-dimensional variational data assimilation is not easy, due to its strong dependence on the adjoint model, which has extremely high computational costs in data coding, maintenance, and updating. In this study, the multigrid technique was introduced into the nonlinear least-squares four-dimensional variational assimilation (NLS-4DVar) method, which is an advanced four-dimensional ensemble-variational method that can be applied without invoking the adjoint models. The multigrid NLS-4DVar (MG-NLS-4DVar) scheme uses the number of grid points to control the scale, with doubling of this number when moving from a coarse to a finer grid. Furthermore, the MG-NLS-4DVar scheme not only retains the advantages of NLS-4DVar, but also sufficiently corrects multiscale errors to achieve a highly accurate analysis. The effectiveness and efficiency of the proposed MG-NLS-4DVar scheme were evaluated by several groups of observing system simulation experiments using the Advanced Research Weather Research and Forecasting Model. MG-NLS-4DVar outperformed NLS-4DVar, with a lower computational cost.

  17. Algebra of 2D periodic operators with local and perpendicular defects

    DEFF Research Database (Denmark)

    Kutsenko, Anton

    2016-01-01

    We show that 2D periodic operators with local and perpendicular defects form an algebra. We provide an algorithm for finding spectrum for such operators. While the continuous spectral components can be computed by simple algebraic operations on some matrix-valued functions and a few number...

  18. Quantum W-algebras and elliptic algebras

    International Nuclear Information System (INIS)

    Feigin, B.; Kyoto Univ.; Frenkel, E.

    1996-01-01

    We define a quantum W-algebra associated to sl N as an associative algebra depending on two parameters. For special values of the parameters, this algebra becomes the ordinary W-algebra of sl N , or the q-deformed classical W-algebra of sl N . We construct free field realizations of the quantum W-algebras and the screening currents. We also point out some interesting elliptic structures arising in these algebras. In particular, we show that the screening currents satisfy elliptic analogues of the Drinfeld relations in U q (n). (orig.)

  19. Analysis of multigrid methods on massively parallel computers: Architectural implications

    Science.gov (United States)

    Matheson, Lesley R.; Tarjan, Robert E.

    1993-01-01

    We study the potential performance of multigrid algorithms running on massively parallel computers with the intent of discovering whether presently envisioned machines will provide an efficient platform for such algorithms. We consider the domain parallel version of the standard V cycle algorithm on model problems, discretized using finite difference techniques in two and three dimensions on block structured grids of size 10(exp 6) and 10(exp 9), respectively. Our models of parallel computation were developed to reflect the computing characteristics of the current generation of massively parallel multicomputers. These models are based on an interconnection network of 256 to 16,384 message passing, 'workstation size' processors executing in an SPMD mode. The first model accomplishes interprocessor communications through a multistage permutation network. The communication cost is a logarithmic function which is similar to the costs in a variety of different topologies. The second model allows single stage communication costs only. Both models were designed with information provided by machine developers and utilize implementation derived parameters. With the medium grain parallelism of the current generation and the high fixed cost of an interprocessor communication, our analysis suggests an efficient implementation requires the machine to support the efficient transmission of long messages, (up to 1000 words) or the high initiation cost of a communication must be significantly reduced through an alternative optimization technique. Furthermore, with variable length message capability, our analysis suggests the low diameter multistage networks provide little or no advantage over a simple single stage communications network.

  20. Fast Erasure and Error decoding of Algebraic Geometry Codes up to the Feng-Rao Bound

    DEFF Research Database (Denmark)

    Jensen, Helge Elbrønd; Sakata, S.; Leonard, D.

    1996-01-01

    This paper gives an errata(that is erasure-and error-) decoding algorithm of one-point algebraic geometry codes up to the Feng-Rao designed minimum distance using Sakata's multidimensional generalization of the Berlekamp-massey algorithm and the votin procedure of Feng and Rao.......This paper gives an errata(that is erasure-and error-) decoding algorithm of one-point algebraic geometry codes up to the Feng-Rao designed minimum distance using Sakata's multidimensional generalization of the Berlekamp-massey algorithm and the votin procedure of Feng and Rao....

  1. Multigrid Reduction in Time for Nonlinear Parabolic Problems

    Energy Technology Data Exchange (ETDEWEB)

    Falgout, R. D. [Lawrence Livermore National Lab. (LLNL), Livermore, CA (United States); Manteuffel, T. A. [Univ. of Colorado, Boulder, CO (United States); O' Neill, B. [Univ. of Colorado, Boulder, CO (United States); Schroder, J. B. [Lawrence Livermore National Lab. (LLNL), Livermore, CA (United States)

    2016-01-04

    The need for parallel-in-time is being driven by changes in computer architectures, where future speed-ups will be available through greater concurrency, but not faster clock speeds, which are stagnant.This leads to a bottleneck for sequential time marching schemes, because they lack parallelism in the time dimension. Multigrid Reduction in Time (MGRIT) is an iterative procedure that allows for temporal parallelism by utilizing multigrid reduction techniques and a multilevel hierarchy of coarse time grids. MGRIT has been shown to be effective for linear problems, with speedups of up to 50 times. The goal of this work is the efficient solution of nonlinear problems with MGRIT, where efficient is defined as achieving similar performance when compared to a corresponding linear problem. As our benchmark, we use the p-Laplacian, where p = 4 corresponds to a well-known nonlinear diffusion equation and p = 2 corresponds to our benchmark linear diffusion problem. When considering linear problems and implicit methods, the use of optimal spatial solvers such as spatial multigrid imply that the cost of one time step evaluation is fixed across temporal levels, which have a large variation in time step sizes. This is not the case for nonlinear problems, where the work required increases dramatically on coarser time grids, where relatively large time steps lead to worse conditioned nonlinear solves and increased nonlinear iteration counts per time step evaluation. This is the key difficulty explored by this paper. We show that by using a variety of strategies, most importantly, spatial coarsening and an alternate initial guess to the nonlinear time-step solver, we can reduce the work per time step evaluation over all temporal levels to a range similar with the corresponding linear problem. This allows for parallel scaling behavior comparable to the corresponding linear problem.

  2. Recoupling Lie algebra and universal ω-algebra

    International Nuclear Information System (INIS)

    Joyce, William P.

    2004-01-01

    We formulate the algebraic version of recoupling theory suitable for commutation quantization over any gradation. This gives a generalization of graded Lie algebra. Underlying this is the new notion of an ω-algebra defined in this paper. ω-algebra is a generalization of algebra that goes beyond nonassociativity. We construct the universal enveloping ω-algebra of recoupling Lie algebras and prove a generalized Poincare-Birkhoff-Witt theorem. As an example we consider the algebras over an arbitrary recoupling of Z n graded Heisenberg Lie algebra. Finally we uncover the usual coalgebra structure of a universal envelope and substantiate its Hopf structure

  3. Reachability for Finite-State Process Algebras Using Static Analysis

    DEFF Research Database (Denmark)

    Skrypnyuk, Nataliya; Nielson, Flemming

    2011-01-01

    of the Data Flow Analysis are used in order to “cut off” some of the branches in the reachability analysis that are not important for determining, whether or not a state is reachable. In this way, it is possible for our reachability algorithm to avoid building large parts of the system altogether and still......In this work we present an algorithm for solving the reachability problem in finite systems that are modelled with process algebras. Our method uses Static Analysis, in particular, Data Flow Analysis, of the syntax of a process algebraic system with multi-way synchronisation. The results...... solve the reachability problem in a precise way....

  4. Fast algorithms for transport models. Final report

    International Nuclear Information System (INIS)

    Manteuffel, T.A.

    1994-01-01

    This project has developed a multigrid in space algorithm for the solution of the S N equations with isotropic scattering in slab geometry. The algorithm was developed for the Modified Linear Discontinuous (MLD) discretization in space which is accurate in the thick diffusion limit. It uses a red/black two-cell μ-line relaxation. This relaxation solves for all angles on two adjacent spatial cells simultaneously. It takes advantage of the rank-one property of the coupling between angles and can perform this inversion in O(N) operations. A version of the multigrid in space algorithm was programmed on the Thinking Machines Inc. CM-200 located at LANL. It was discovered that on the CM-200 a block Jacobi type iteration was more efficient than the block red/black iteration. Given sufficient processors all two-cell block inversions can be carried out simultaneously with a small number of parallel steps. The bottleneck is the need for sums of N values, where N is the number of discrete angles, each from a different processor. These are carried out by machine intrinsic functions and are well optimized. The overall algorithm has computational complexity O(log(M)), where M is the number of spatial cells. The algorithm is very efficient and represents the state-of-the-art for isotropic problems in slab geometry. For anisotropic scattering in slab geometry, a multilevel in angle algorithm was developed. A parallel version of the multilevel in angle algorithm has also been developed. Upon first glance, the shifted transport sweep has limited parallelism. Once the right-hand-side has been computed, the sweep is completely parallel in angle, becoming N uncoupled initial value ODE's. The author has developed a cyclic reduction algorithm that renders it parallel with complexity O(log(M)). The multilevel in angle algorithm visits log(N) levels, where shifted transport sweeps are performed. The overall complexity is O(log(N)log(M))

  5. Differential Hopf algebra structures on the universal enveloping algebra ofa Lie algebra

    NARCIS (Netherlands)

    N.W. van den Hijligenberg; R. Martini

    1995-01-01

    textabstractWe discuss a method to construct a De Rham complex (differential algebra) of Poincar'e-Birkhoff-Witt-type on the universal enveloping algebra of a Lie algebra $g$. We determine the cases in which this gives rise to a differential Hopf algebra that naturally extends the Hopf algebra

  6. Blockspin and multigrid for staggered fermions in non-abelian gauge fields

    International Nuclear Information System (INIS)

    Kalkreuter, T.; Mack, G.; Speh, M.

    1991-07-01

    We discuss blockspins for staggered fermions, i.e. averaging and interpolation procedures which are needed in a real space renormalization group approach to gauge theories with staggered fermions and in a multigrid approach to the computation of gauge covariant propagators. The discussion starts from the requirement that the symmetries of the free action should be preserved by the blocking procedure in the limit of a pure gauge. A definition of an averaging kernel as a solution of a gauge covariant eigenvalue equation is proposed, and the properties of a corresponding interpolation kernel are examined in the light of general criteria for good choices of blockspins. Some results of multigrid computation of bosonic propagation in an SU(2) gauge field in 4 dimensions are also presented. (orig.)

  7. The Yoneda algebra of a K2 algebra need not be another K2 algebra

    OpenAIRE

    Cassidy, T.; Phan, C.; Shelton, B.

    2010-01-01

    The Yoneda algebra of a Koszul algebra or a D-Koszul algebra is Koszul. K2 algebras are a natural generalization of Koszul algebras, and one would hope that the Yoneda algebra of a K2 algebra would be another K2 algebra. We show that this is not necessarily the case by constructing a monomial K2 algebra for which the corresponding Yoneda algebra is not K2.

  8. A cluster algorithm for graphs

    NARCIS (Netherlands)

    S. van Dongen

    2000-01-01

    textabstractA cluster algorithm for graphs called the emph{Markov Cluster algorithm (MCL~algorithm) is introduced. The algorithm provides basically an interface to an algebraic process defined on stochastic matrices, called the MCL~process. The graphs may be both weighted (with nonnegative weight)

  9. Multigrid for the Galerkin least squares method in linear elasticity: The pure displacement problem

    Energy Technology Data Exchange (ETDEWEB)

    Yoo, Jaechil [Univ. of Wisconsin, Madison, WI (United States)

    1996-12-31

    Franca and Stenberg developed several Galerkin least squares methods for the solution of the problem of linear elasticity. That work concerned itself only with the error estimates of the method. It did not address the related problem of finding effective methods for the solution of the associated linear systems. In this work, we prove the convergence of a multigrid (W-cycle) method. This multigrid is robust in that the convergence is uniform as the parameter, v, goes to 1/2 Computational experiments are included.

  10. Multigrid and defect correction for the steady Navier-Stokes equations

    NARCIS (Netherlands)

    Koren, B.

    1990-01-01

    Theoretical and experimental convergence results are presented for nonlinear multigrid and iterative defect correction applied to finite volume discretizations of the full, steady, 2D, compressible Navier-Stokes equations. Iterative defect correction is introduced for circumventing the difficulty in

  11. Choosing processor array configuration by performance modeling for a highly parallel linear algebra algorithm

    International Nuclear Information System (INIS)

    Littlefield, R.J.; Maschhoff, K.J.

    1991-04-01

    Many linear algebra algorithms utilize an array of processors across which matrices are distributed. Given a particular matrix size and a maximum number of processors, what configuration of processors, i.e., what size and shape array, will execute the fastest? The answer to this question depends on tradeoffs between load balancing, communication startup and transfer costs, and computational overhead. In this paper we analyze in detail one algorithm: the blocked factored Jacobi method for solving dense eigensystems. A performance model is developed to predict execution time as a function of the processor array and matrix sizes, plus the basic computation and communication speeds of the underlying computer system. In experiments on a large hypercube (up to 512 processors), this model has been found to be highly accurate (mean error ∼ 2%) over a wide range of matrix sizes (10 x 10 through 200 x 200) and processor counts (1 to 512). The model reveals, and direct experiment confirms, that the tradeoffs mentioned above can be surprisingly complex and counterintuitive. We propose decision procedures based directly on the performance model to choose configurations for fastest execution. The model-based decision procedures are compared to a heuristic strategy and shown to be significantly better. 7 refs., 8 figs., 1 tab

  12. A Cost-Effective Smoothed Multigrid with Modified Neighborhood-Based Aggregation for Markov Chains

    Directory of Open Access Journals (Sweden)

    Zhao-Li Shen

    2015-01-01

    Full Text Available Smoothed aggregation multigrid method is considered for computing stationary distributions of Markov chains. A judgement which determines whether to implement the whole aggregation procedure is proposed. Through this strategy, a large amount of time in the aggregation procedure is saved without affecting the convergence behavior. Besides this, we explain the shortage and irrationality of the Neighborhood-Based aggregation which is commonly used in multigrid methods. Then a modified version is presented to remedy and improve it. Numerical experiments on some typical Markov chain problems are reported to illustrate the performance of these methods.

  13. A Line Search Multilevel Truncated Newton Algorithm for Computing the Optical Flow

    Directory of Open Access Journals (Sweden)

    Lluís Garrido

    2015-06-01

    Full Text Available We describe the implementation details and give the experimental results of three optimization algorithms for dense optical flow computation. In particular, using a line search strategy, we evaluate the performance of the unilevel truncated Newton method (LSTN, a multiresolution truncated Newton (MR/LSTN and a full multigrid truncated Newton (FMG/LSTN. We use three image sequences and four models of optical flow for performance evaluation. The FMG/LSTN algorithm is shown to lead to better optical flow estimation with less computational work than both the LSTN and MR/LSTN algorithms.

  14. Cylindric-like algebras and algebraic logic

    CERN Document Server

    Ferenczi, Miklós; Németi, István

    2013-01-01

    Algebraic logic is a subject in the interface between logic, algebra and geometry, it has strong connections with category theory and combinatorics. Tarski’s quest for finding structure in logic leads to cylindric-like algebras as studied in this book, they are among the main players in Tarskian algebraic logic. Cylindric algebra theory can be viewed in many ways:  as an algebraic form of definability theory, as a study of higher-dimensional relations, as an enrichment of Boolean Algebra theory, or, as logic in geometric form (“cylindric” in the name refers to geometric aspects). Cylindric-like algebras have a wide range of applications, in, e.g., natural language theory, data-base theory, stochastics, and even in relativity theory. The present volume, consisting of 18 survey papers, intends to give an overview of the main achievements and new research directions in the past 30 years, since the publication of the Henkin-Monk-Tarski monographs. It is dedicated to the memory of Leon Henkin.

  15. Pole-placement Predictive Functional Control for under-damped systems with real numbers algebra.

    Science.gov (United States)

    Zabet, K; Rossiter, J A; Haber, R; Abdullah, M

    2017-11-01

    This paper presents the new algorithm of PP-PFC (Pole-placement Predictive Functional Control) for stable, linear under-damped higher-order processes. It is shown that while conventional PFC aims to get first-order exponential behavior, this is not always straightforward with significant under-damped modes and hence a pole-placement PFC algorithm is proposed which can be tuned more precisely to achieve the desired dynamics, but exploits complex number algebra and linear combinations in order to deliver guarantees of stability and performance. Nevertheless, practical implementation is easier by avoiding complex number algebra and hence a modified formulation of the PP-PFC algorithm is also presented which utilises just real numbers while retaining the key attributes of simple algebra, coding and tuning. The potential advantages are demonstrated with numerical examples and real-time control of a laboratory plant. Copyright © 2017 ISA. All rights reserved.

  16. Algorithmic cryptanalysis

    CERN Document Server

    Joux, Antoine

    2009-01-01

    Illustrating the power of algorithms, Algorithmic Cryptanalysis describes algorithmic methods with cryptographically relevant examples. Focusing on both private- and public-key cryptographic algorithms, it presents each algorithm either as a textual description, in pseudo-code, or in a C code program.Divided into three parts, the book begins with a short introduction to cryptography and a background chapter on elementary number theory and algebra. It then moves on to algorithms, with each chapter in this section dedicated to a single topic and often illustrated with simple cryptographic applic

  17. Multidimensional radiative transfer with multilevel atoms. II. The non-linear multigrid method.

    Science.gov (United States)

    Fabiani Bendicho, P.; Trujillo Bueno, J.; Auer, L.

    1997-08-01

    A new iterative method for solving non-LTE multilevel radiative transfer (RT) problems in 1D, 2D or 3D geometries is presented. The scheme obtains the self-consistent solution of the kinetic and RT equations at the cost of only a few (iteration (Brandt, 1977, Math. Comp. 31, 333; Hackbush, 1985, Multi-Grid Methods and Applications, springer-Verlag, Berlin), an efficient multilevel RT scheme based on Gauss-Seidel iterations (cf. Trujillo Bueno & Fabiani Bendicho, 1995ApJ...455..646T), and accurate short-characteristics formal solution techniques. By combining a valid stopping criterion with a nested-grid strategy a converged solution with the desired true error is automatically guaranteed. Contrary to the current operator splitting methods the very high convergence speed of the new RT method does not deteriorate when the grid spatial resolution is increased. With this non-linear multigrid method non-LTE problems discretized on N grid points are solved in O(N) operations. The nested multigrid RT method presented here is, thus, particularly attractive in complicated multilevel transfer problems where small grid-sizes are required. The properties of the method are analyzed both analytically and with illustrative multilevel calculations for Ca II in 1D and 2D schematic model atmospheres.

  18. Differential Hopf algebra structures on the universal enveloping algebra of a Lie algebra

    NARCIS (Netherlands)

    van den Hijligenberg, N.W.; van den Hijligenberg, N.W.; Martini, Ruud

    1995-01-01

    We discuss a method to construct a De Rham complex (differential algebra) of Poincar'e-Birkhoff-Witt-type on the universal enveloping algebra of a Lie algebra $g$. We determine the cases in which this gives rise to a differential Hopf algebra that naturally extends the Hopf algebra structure of

  19. DDASAC, Double-Precision Differential or Algebraic Sensitivity Analysis

    International Nuclear Information System (INIS)

    Caracotsios, M.; Stewart, W.E.; Petzold, L.

    1997-01-01

    1 - Description of program or function: DDASAC solves nonlinear initial-value problems involving stiff implicit systems of ordinary differential and algebraic equations. Purely algebraic nonlinear systems can also be solved, given an initial guess within the region of attraction of a solution. Options include automatic reconciliation of inconsistent initial states and derivatives, automatic initial step selection, direct concurrent parametric sensitivity analysis, and stopping at a prescribed value of any user-defined functional of the current solution vector. Local error control (in the max-norm or the 2-norm) is provided for the state vector and can include the sensitivities on request. 2 - Method of solution: Reconciliation of initial conditions is done with a damped Newton algorithm adapted from Bain and Stewart (1991). Initial step selection is done by the first-order algorithm of Shampine (1987), extended here to differential-algebraic equation systems. The solution is continued with the DASSL predictor- corrector algorithm (Petzold 1983, Brenan et al. 1989) with the initial acceleration phase detected and with row scaling of the Jacobian added. The backward-difference formulas for the predictor and corrector are expressed in divide-difference form, and the fixed-leading-coefficient form of the corrector (Jackson and Sacks-Davis 1980, Brenan et al. 1989) is used. Weights for error tests are updated in each step with the user's tolerances at the predicted state. Sensitivity analysis is performed directly on the corrector equations as given by Catacotsios and Stewart (1985) and is extended here to the initialization when needed. 3 - Restrictions on the complexity of the problem: This algorithm, like DASSL, performs well on differential-algebraic systems of index 0 and 1 but not on higher-index systems; see Brenan et al. (1989). The user assigns the work array lengths and the output unit. The machine number range and precision are determined at run time by a

  20. Genetic algorithms in teaching artificial intelligence (automated generation of specific algebras)

    Science.gov (United States)

    Habiballa, Hashim; Jendryscik, Radek

    2017-11-01

    The problem of teaching essential Artificial Intelligence (AI) methods is an important task for an educator in the branch of soft-computing. The key focus is often given to proper understanding of the principle of AI methods in two essential points - why we use soft-computing methods at all and how we apply these methods to generate reasonable results in sensible time. We present one interesting problem solved in the non-educational research concerning automated generation of specific algebras in the huge search space. We emphasize above mentioned points as an educational case study of an interesting problem in automated generation of specific algebras.

  1. Algebraic theory of locally nilpotent derivations

    CERN Document Server

    Freudenburg, Gene

    2017-01-01

    This book explores the theory and application of locally nilpotent derivations, a subject motivated by questions in affine algebraic geometry and having fundamental connections to areas such as commutative algebra, representation theory, Lie algebras and differential equations. The author provides a unified treatment of the subject, beginning with 16 First Principles on which the theory is based. These are used to establish classical results, such as Rentschler's Theorem for the plane and the Cancellation Theorem for Curves. More recent results, such as Makar-Limanov's theorem for locally nilpotent derivations of polynomial rings, are also discussed. Topics of special interest include progress in classifying additive actions on three-dimensional affine space, finiteness questions (Hilbert's 14th Problem), algorithms, the Makar-Limanov invariant, and connections to the Cancellation Problem and the Embedding Problem. A lot of new material is included in this expanded second edition, such as canonical factoriza...

  2. A multigrid Newton-Krylov method for flux-limited radiation diffusion

    International Nuclear Information System (INIS)

    Rider, W.J.; Knoll, D.A.; Olson, G.L.

    1998-01-01

    The authors focus on the integration of radiation diffusion including flux-limited diffusion coefficients. The nonlinear integration is accomplished with a Newton-Krylov method preconditioned with a multigrid Picard linearization of the governing equations. They investigate the efficiency of the linear and nonlinear iterative techniques

  3. Introduction to relation algebras relation algebras

    CERN Document Server

    Givant, Steven

    2017-01-01

    The first volume of a pair that charts relation algebras from novice to expert level, this text offers a comprehensive grounding for readers new to the topic. Upon completing this introduction, mathematics students may delve into areas of active research by progressing to the second volume, Advanced Topics in Relation Algebras; computer scientists, philosophers, and beyond will be equipped to apply these tools in their own field. The careful presentation establishes first the arithmetic of relation algebras, providing ample motivation and examples, then proceeds primarily on the basis of algebraic constructions: subalgebras, homomorphisms, quotient algebras, and direct products. Each chapter ends with a historical section and a substantial number of exercises. The only formal prerequisite is a background in abstract algebra and some mathematical maturity, though the reader will also benefit from familiarity with Boolean algebra and naïve set theory. The measured pace and outstanding clarity are particularly ...

  4. Damage mapping in structural health monitoring using a multi-grid architecture

    Energy Technology Data Exchange (ETDEWEB)

    Mathews, V. John [Dept. of Electrical and Computer Engineering, University of Utah, Salt Lake City, UT 84112 (United States)

    2015-03-31

    This paper presents a multi-grid architecture for tomography-based damage mapping of composite aerospace structures. The system employs an array of piezo-electric transducers bonded on the structure. Each transducer may be used as an actuator as well as a sensor. The structure is excited sequentially using the actuators and the guided waves arriving at the sensors in response to the excitations are recorded for further analysis. The sensor signals are compared to their baseline counterparts and a damage index is computed for each actuator-sensor pair. These damage indices are then used as inputs to the tomographic reconstruction system. Preliminary damage maps are reconstructed on multiple coordinate grids defined on the structure. These grids are shifted versions of each other where the shift is a fraction of the spatial sampling interval associated with each grid. These preliminary damage maps are then combined to provide a reconstruction that is more robust to measurement noise in the sensor signals and the ill-conditioned problem formulation for single-grid algorithms. Experimental results on a composite structure with complexity that is representative of aerospace structures included in the paper demonstrate that for sufficiently high sensor densities, the algorithm of this paper is capable of providing damage detection and characterization with accuracy comparable to traditional C-scan and A-scan-based ultrasound non-destructive inspection systems quickly and without human supervision.

  5. Seeking Space Aliens and the Strong Approximation Property: A (disjoint) Study in Dust Plumes on Planetary Satellites and Nonsymmetric Algebraic Multigrid

    Science.gov (United States)

    Southworth, Benjamin Scott

    linear systems arises often in the modeling of biological and physical phenomenon, data analysis through graphs and networks, and other scientific applications. This work focuses primarily on linear systems resulting from the discretization of partial differential equations (PDEs). Because solving linear systems is the bottleneck of many large simulation codes, there is a rich field of research in developing "fast" solvers, with the ultimate goal being a method that solves an n x n linear system in O(n) operations. One of the most effective classes of solvers is algebraic multigrid (AMG), which is a multilevel iterative method based on projecting the problem into progressively smaller spaces, and scales like O(n) or O(nlog n) for certain classes of problems. The field of AMG is well-developed for symmetric positive definite matrices, and is typically most effective on linear systems resulting from the discretization of scalar elliptic PDEs, such as the heat equation. Systems of PDEs can add additional difficulties, but the underlying linear algebraic theory is consistent and, in many cases, an elliptic system of PDEs can be handled well by AMG with appropriate modifications of the solver. Solving general, nonsymmetric linear systems remains the wild west of AMG (and other fast solvers), lacking significant results in convergence theory as well as robust methods. Here, we develop new theoretical motivation and practical variations of AMG to solve nonsymmetric linear systems, often resulting from the discretization of hyperbolic PDEs. In particular, multilevel convergence of AMG for nonsymmetric systems is proven for the first time. A new nonsymmetric AMG solver is also developed based on an approximate ideal restriction, referred to as AIR, which is able to solve advection-dominated, hyperbolic-type problems that are outside the scope of existing AMG solvers and other fast iterative methods. AIR demonstrates scalable convergence on unstructured meshes, in multiple

  6. Multigrid time-accurate integration of Navier-Stokes equations

    Science.gov (United States)

    Arnone, Andrea; Liou, Meng-Sing; Povinelli, Louis A.

    1993-01-01

    Efficient acceleration techniques typical of explicit steady-state solvers are extended to time-accurate calculations. Stability restrictions are greatly reduced by means of a fully implicit time discretization. A four-stage Runge-Kutta scheme with local time stepping, residual smoothing, and multigridding is used instead of traditional time-expensive factorizations. Some applications to natural and forced unsteady viscous flows show the capability of the procedure.

  7. Computer methods in general relativity: algebraic computing

    CERN Document Server

    Araujo, M E; Skea, J E F; Koutras, A; Krasinski, A; Hobill, D; McLenaghan, R G; Christensen, S M

    1993-01-01

    Karlhede & MacCallum [1] gave a procedure for determining the Lie algebra of the isometry group of an arbitrary pseudo-Riemannian manifold, which they intended to im- plement using the symbolic manipulation package SHEEP but never did. We have recently finished making this procedure explicit by giving an algorithm suitable for implemen- tation on a computer [2]. Specifically, we have written an algorithm for determining the isometry group of a spacetime (in four dimensions), and partially implemented this algorithm using the symbolic manipulation package CLASSI, which is an extension of SHEEP.

  8. New Multigrid Method Including Elimination Algolithm Based on High-Order Vector Finite Elements in Three Dimensional Magnetostatic Field Analysis

    Science.gov (United States)

    Hano, Mitsuo; Hotta, Masashi

    A new multigrid method based on high-order vector finite elements is proposed in this paper. Low level discretizations in this method are obtained by using low-order vector finite elements for the same mesh. Gauss-Seidel method is used as a smoother, and a linear equation of lowest level is solved by ICCG method. But it is often found that multigrid solutions do not converge into ICCG solutions. An elimination algolithm of constant term using a null space of the coefficient matrix is also described. In three dimensional magnetostatic field analysis, convergence time and number of iteration of this multigrid method are discussed with the convectional ICCG method.

  9. Primal-Dual Interior Point Multigrid Method for Topology Optimization

    Czech Academy of Sciences Publication Activity Database

    Kočvara, Michal; Mohammed, S.

    2016-01-01

    Roč. 38, č. 5 (2016), B685-B709 ISSN 1064-8275 Grant - others:European Commission - EC(XE) 313781 Institutional support: RVO:67985556 Keywords : topology optimization * multigrid method s * interior point method Subject RIV: BA - General Mathematics Impact factor: 2.195, year: 2016 http://library.utia.cas.cz/separaty/2016/MTR/kocvara-0462418.pdf

  10. Multi-Grid detector for neutron spectroscopy: results obtained on time-of-flight spectrometer CNCS

    Science.gov (United States)

    Anastasopoulos, M.; Bebb, R.; Berry, K.; Birch, J.; Bryś, T.; Buffet, J.-C.; Clergeau, J.-F.; Deen, P. P.; Ehlers, G.; van Esch, P.; Everett, S. M.; Guerard, B.; Hall-Wilton, R.; Herwig, K.; Hultman, L.; Höglund, C.; Iruretagoiena, I.; Issa, F.; Jensen, J.; Khaplanov, A.; Kirstein, O.; Lopez Higuera, I.; Piscitelli, F.; Robinson, L.; Schmidt, S.; Stefanescu, I.

    2017-04-01

    The Multi-Grid detector technology has evolved from the proof-of-principle and characterisation stages. Here we report on the performance of the Multi-Grid detector, the MG.CNCS prototype, which has been installed and tested at the Cold Neutron Chopper Spectrometer, CNCS at SNS. This has allowed a side-by-side comparison to the performance of 3He detectors on an operational instrument. The demonstrator has an active area of 0.2 m2. It is specifically tailored to the specifications of CNCS. The detector was installed in June 2016 and has operated since then, collecting neutron scattering data in parallel to the He-3 detectors of CNCS. In this paper, we present a comprehensive analysis of this data, in particular on instrument energy resolution, rate capability, background and relative efficiency. Stability, gamma-ray and fast neutron sensitivity have also been investigated. The effect of scattering in the detector components has been measured and provides input to comparison for Monte Carlo simulations. All data is presented in comparison to that measured by the 3He detectors simultaneously, showing that all features recorded by one detector are also recorded by the other. The energy resolution matches closely. We find that the Multi-Grid is able to match the data collected by 3He, and see an indication of a considerable advantage in the count rate capability. Based on these results, we are confident that the Multi-Grid detector will be capable of producing high quality scientific data on chopper spectrometers utilising the unprecedented neutron flux of the ESS.

  11. Algebraic Verification Method for SEREs Properties via Groebner Bases Approaches

    Directory of Open Access Journals (Sweden)

    Ning Zhou

    2013-01-01

    Full Text Available This work presents an efficient solution using computer algebra system to perform linear temporal properties verification for synchronous digital systems. The method is essentially based on both Groebner bases approaches and symbolic simulation. A mechanism for constructing canonical polynomial set based symbolic representations for both circuit descriptions and assertions is studied. We then present a complete checking algorithm framework based on these algebraic representations by using Groebner bases. The computational experience result in this work shows that the algebraic approach is a quite competitive checking method and will be a useful supplement to the existent verification methods based on simulation.

  12. From Rota-Baxter algebras to pre-Lie algebras

    International Nuclear Information System (INIS)

    An Huihui; Ba, Chengming

    2008-01-01

    Rota-Baxter algebras were introduced to solve some analytic and combinatorial problems and have appeared in many fields in mathematics and mathematical physics. Rota-Baxter algebras provide a construction of pre-Lie algebras from associative algebras. In this paper, we give all Rota-Baxter operators of weight 1 on complex associative algebras in dimension ≤3 and their corresponding pre-Lie algebras

  13. Quartic Poisson algebras and quartic associative algebras and realizations as deformed oscillator algebras

    International Nuclear Information System (INIS)

    Marquette, Ian

    2013-01-01

    We introduce the most general quartic Poisson algebra generated by a second and a fourth order integral of motion of a 2D superintegrable classical system. We obtain the corresponding quartic (associative) algebra for the quantum analog, extend Daskaloyannis construction obtained in context of quadratic algebras, and also obtain the realizations as deformed oscillator algebras for this quartic algebra. We obtain the Casimir operator and discuss how these realizations allow to obtain the finite-dimensional unitary irreducible representations of quartic algebras and obtain algebraically the degenerate energy spectrum of superintegrable systems. We apply the construction and the formula obtained for the structure function on a superintegrable system related to type I Laguerre exceptional orthogonal polynomials introduced recently

  14. Rotor Cascade Shape Optimization with Unsteady Passing Wakes Using Implicit Dual-Time Stepping and a Genetic Algorithm

    Directory of Open Access Journals (Sweden)

    Eun Seok Lee

    2003-01-01

    Full Text Available An axial turbine rotor cascade-shape optimization with unsteady passing wakes was performed to obtain an improved aerodynamic performance using an unsteady flow, Reynolds-averaged Navier-Stokes equations solver that was based on explicit, finite difference; Runge-Kutta multistage time marching; and the diagonalized alternating direction implicit scheme. The code utilized Baldwin-Lomax algebraic and k-ε turbulence modeling. The full approximation storage multigrid method and preconditioning were implemented as iterative convergence-acceleration techniques. An implicit dual-time stepping method was incorporated in order to simulate the unsteady flow fields. The objective function was defined as minimization of total pressure loss and maximization of lift, while the mass flow rate was fixed during the optimization. The design variables were several geometric parameters characterizing airfoil leading edge, camber, stagger angle, and inter-row spacing. The genetic algorithm was used as an optimizer, and the penalty method was introduced for combining the constraints with the objective function. Each individual's objective function was computed simultaneously by using a 32-processor distributedmemory computer. The optimization results indicated that only minor improvements are possible in unsteady rotor/stator aerodynamics by varying these geometric parameters.

  15. SYNTHESIS METHODS OF ALGEBRAIC NORMAL FORM OF MANY-VALUED LOGIC FUNCTIONS

    Directory of Open Access Journals (Sweden)

    A. V. Sokolov

    2016-01-01

    Full Text Available The rapid development of methods of error-correcting coding, cryptography, and signal synthesis theory based on the principles of many-valued logic determines the need for a more detailed study of the forms of representation of functions of many-valued logic. In particular the algebraic normal form of Boolean functions, also known as Zhegalkin polynomial, that well describe many of the cryptographic properties of Boolean functions is widely used. In this article, we formalized the notion of algebraic normal form for many-valued logic functions. We developed a fast method of synthesis of algebraic normal form of 3-functions and 5-functions that work similarly to the Reed-Muller transform for Boolean functions: on the basis of recurrently synthesized transform matrices. We propose the hypothesis, which determines the rules of the synthesis of these matrices for the transformation from the truth table to the coefficients of the algebraic normal form and the inverse transform for any given number of variables of 3-functions or 5-functions. The article also introduces the definition of algebraic degree of nonlinearity of the functions of many-valued logic and the S-box, based on the principles of many-valued logic. Thus, the methods of synthesis of algebraic normal form of 3-functions applied to the known construction of recurrent synthesis of S-boxes of length N = 3k, whereby their algebraic degrees of nonlinearity are computed. The results could be the basis for further theoretical research and practical applications such as: the development of new cryptographic primitives, error-correcting codes, algorithms of data compression, signal structures, and algorithms of block and stream encryption, all based on the perspective principles of many-valued logic. In addition, the fast method of synthesis of algebraic normal form of many-valued logic functions is the basis for their software and hardware implementation.

  16. Yoneda algebras of almost Koszul algebras

    Indian Academy of Sciences (India)

    Abstract. Let k be an algebraically closed field, A a finite dimensional connected. (p,q)-Koszul self-injective algebra with p, q ≥ 2. In this paper, we prove that the. Yoneda algebra of A is isomorphic to a twisted polynomial algebra A![t; β] in one inde- terminate t of degree q +1 in which A! is the quadratic dual of A, β is an ...

  17. Bôcher and Abstract Contractions of 2nd Order Quadratic Algebras

    Science.gov (United States)

    Escobar-Ruiz, Mauricio A.; Kalnins, Ernest G.; Miller, Willar, Jr.; Subag, Eyal

    2017-03-01

    Quadratic algebras are generalizations of Lie algebras which include the symmetry algebras of 2nd order superintegrable systems in 2 dimensions as special cases. The superintegrable systems are exactly solvable physical systems in classical and quantum mechanics. Distinct superintegrable systems and their quadratic algebras can be related by geometric contractions, induced by Bôcher contractions of the conformal Lie algebra {so}(4,C) to itself. In this paper we give a precise definition of Bôcher contractions and show how they can be classified. They subsume well known contractions of {e}(2,C) and {so}(3,C) and have important physical and geometric meanings, such as the derivation of the Askey scheme for obtaining all hypergeometric orthogonal polynomials as limits of Racah/Wilson polynomials. We also classify abstract nondegenerate quadratic algebras in terms of an invariant that we call a canonical form. We describe an algorithm for finding the canonical form of such algebras. We calculate explicitly all canonical forms arising from quadratic algebras of 2D nondegenerate superintegrable systems on constant curvature spaces and Darboux spaces. We further discuss contraction of quadratic algebras, focusing on those coming from superintegrable systems.

  18. Communication Avoiding and Overlapping for Numerical Linear Algebra

    Science.gov (United States)

    2012-05-08

    future exascale systems, communication cost must be avoided or overlapped. Communication-avoiding 2.5D algorithms improve scalability by reducing...linear algebra problems to future exascale systems, communication cost must be avoided or overlapped. Communication-avoiding 2.5D algorithms improve...will continue to grow relative to the cost of computation. With exascale computing as the long-term goal, the community needs to develop techniques

  19. Formalized Linear Algebra over Elementary Divisor Rings in Coq

    OpenAIRE

    Cano , Guillaume; Cohen , Cyril; Dénès , Maxime; Mörtberg , Anders; Siles , Vincent

    2016-01-01

    International audience; This paper presents a Coq formalization of linear algebra over elementary divisor rings, that is, rings where every matrix is equivalent to a matrix in Smith normal form. The main results are the formalization that these rings support essential operations of linear algebra, the classification theorem of finitely pre-sented modules over such rings and the uniqueness of the Smith normal form up to multiplication by units. We present formally verified algorithms comput-in...

  20. Algebraic Modeling of Topological and Computational Structures and Applications

    CERN Document Server

    Theodorou, Doros; Stefaneas, Petros; Kauffman, Louis

    2017-01-01

    This interdisciplinary book covers a wide range of subjects, from pure mathematics (knots, braids, homotopy theory, number theory) to more applied mathematics (cryptography, algebraic specification of algorithms, dynamical systems) and concrete applications (modeling of polymers and ionic liquids, video, music and medical imaging). The main mathematical focus throughout the book is on algebraic modeling with particular emphasis on braid groups. The research methods include algebraic modeling using topological structures, such as knots, 3-manifolds, classical homotopy groups, and braid groups. The applications address the simulation of polymer chains and ionic liquids, as well as the modeling of natural phenomena via topological surgery. The treatment of computational structures, including finite fields and cryptography, focuses on the development of novel techniques. These techniques can be applied to the design of algebraic specifications for systems modeling and verification. This book is the outcome of a w...

  1. Quantum cluster algebras and quantum nilpotent algebras

    Science.gov (United States)

    Goodearl, Kenneth R.; Yakimov, Milen T.

    2014-01-01

    A major direction in the theory of cluster algebras is to construct (quantum) cluster algebra structures on the (quantized) coordinate rings of various families of varieties arising in Lie theory. We prove that all algebras in a very large axiomatically defined class of noncommutative algebras possess canonical quantum cluster algebra structures. Furthermore, they coincide with the corresponding upper quantum cluster algebras. We also establish analogs of these results for a large class of Poisson nilpotent algebras. Many important families of coordinate rings are subsumed in the class we are covering, which leads to a broad range of applications of the general results to the above-mentioned types of problems. As a consequence, we prove the Berenstein–Zelevinsky conjecture [Berenstein A, Zelevinsky A (2005) Adv Math 195:405–455] for the quantized coordinate rings of double Bruhat cells and construct quantum cluster algebra structures on all quantum unipotent groups, extending the theorem of Geiß et al. [Geiß C, et al. (2013) Selecta Math 19:337–397] for the case of symmetric Kac–Moody groups. Moreover, we prove that the upper cluster algebras of Berenstein et al. [Berenstein A, et al. (2005) Duke Math J 126:1–52] associated with double Bruhat cells coincide with the corresponding cluster algebras. PMID:24982197

  2. An introduction to algebraic geometry and algebraic groups

    CERN Document Server

    Geck, Meinolf

    2003-01-01

    An accessible text introducing algebraic geometries and algebraic groups at advanced undergraduate and early graduate level, this book develops the language of algebraic geometry from scratch and uses it to set up the theory of affine algebraic groups from first principles.Building on the background material from algebraic geometry and algebraic groups, the text provides an introduction to more advanced and specialised material. An example is the representation theory of finite groups of Lie type.The text covers the conjugacy of Borel subgroups and maximal tori, the theory of algebraic groups

  3. Higher-order schemes for the Laplace transformation method for parabolic problems

    KAUST Repository

    Douglas, C.

    2011-01-01

    In this paper we solve linear parabolic problems using the three stage noble algorithms. First, the time discretization is approximated using the Laplace transformation method, which is both parallel in time (and can be in space, too) and extremely high order convergent. Second, higher-order compact schemes of order four and six are used for the the spatial discretization. Finally, the discretized linear algebraic systems are solved using multigrid to show the actual convergence rate for numerical examples, which are compared to other numerical solution methods. © 2011 Springer-Verlag.

  4. Generalization of Risch's algorithm to special functions

    International Nuclear Information System (INIS)

    Raab, Clemens G.

    2013-05-01

    Symbolic integration deals with the evaluation of integrals in closed form. We present an overview of Risch's algorithm including recent developments. The algorithms discussed are suited for both indefinite and definite integration. They can also be used to compute linear relations among integrals and to find identities for special functions given by parameter integrals. The aim of this presentation is twofold: to introduce the reader to some basic ideas of differential algebra in the context of integration and to raise awareness in the physics community of computer algebra algorithms for indefinite and definite integration.

  5. Spectral analysis and multigrid preconditioners for two-dimensional space-fractional diffusion equations

    Science.gov (United States)

    Moghaderi, Hamid; Dehghan, Mehdi; Donatelli, Marco; Mazza, Mariarosa

    2017-12-01

    Fractional diffusion equations (FDEs) are a mathematical tool used for describing some special diffusion phenomena arising in many different applications like porous media and computational finance. In this paper, we focus on a two-dimensional space-FDE problem discretized by means of a second order finite difference scheme obtained as combination of the Crank-Nicolson scheme and the so-called weighted and shifted Grünwald formula. By fully exploiting the Toeplitz-like structure of the resulting linear system, we provide a detailed spectral analysis of the coefficient matrix at each time step, both in the case of constant and variable diffusion coefficients. Such a spectral analysis has a very crucial role, since it can be used for designing fast and robust iterative solvers. In particular, we employ the obtained spectral information to define a Galerkin multigrid method based on the classical linear interpolation as grid transfer operator and damped-Jacobi as smoother, and to prove the linear convergence rate of the corresponding two-grid method. The theoretical analysis suggests that the proposed grid transfer operator is strong enough for working also with the V-cycle method and the geometric multigrid. On this basis, we introduce two computationally favourable variants of the proposed multigrid method and we use them as preconditioners for Krylov methods. Several numerical results confirm that the resulting preconditioning strategies still keep a linear convergence rate.

  6. On the topology of real algebraic plane curves

    DEFF Research Database (Denmark)

    Cheng, Jinsan; Lazard, Sylvain; Peñaranda, Luis

    2010-01-01

    We revisit the problem of computing the topology and geometry of a real algebraic plane curve. The topology is of prime interest but geometric information, such as the position of singular and critical points, is also relevant. A challenge is to compute efficiently this information for the given...... and isolation with rational univariate representations. This has the advantage of avoiding computations with polynomials with algebraic coefficients, even in non-generic positions. Our algorithm isolates critical points in boxes and computes a decomposition of the plane by rectangular boxes. This decomposition...

  7. Efficiency Analysis of the Parallel Implementation of the SIMPLE Algorithm on Multiprocessor Computers

    Science.gov (United States)

    Lashkin, S. V.; Kozelkov, A. S.; Yalozo, A. V.; Gerasimov, V. Yu.; Zelensky, D. K.

    2017-12-01

    This paper describes the details of the parallel implementation of the SIMPLE algorithm for numerical solution of the Navier-Stokes system of equations on arbitrary unstructured grids. The iteration schemes for the serial and parallel versions of the SIMPLE algorithm are implemented. In the description of the parallel implementation, special attention is paid to computational data exchange among processors under the condition of the grid model decomposition using fictitious cells. We discuss the specific features for the storage of distributed matrices and implementation of vector-matrix operations in parallel mode. It is shown that the proposed way of matrix storage reduces the number of interprocessor exchanges. A series of numerical experiments illustrates the effect of the multigrid SLAE solver tuning on the general efficiency of the algorithm; the tuning involves the types of the cycles used (V, W, and F), the number of iterations of a smoothing operator, and the number of cells for coarsening. Two ways (direct and indirect) of efficiency evaluation for parallelization of the numerical algorithm are demonstrated. The paper presents the results of solving some internal and external flow problems with the evaluation of parallelization efficiency by two algorithms. It is shown that the proposed parallel implementation enables efficient computations for the problems on a thousand processors. Based on the results obtained, some general recommendations are made for the optimal tuning of the multigrid solver, as well as for selecting the optimal number of cells per processor.

  8. Geometric Algebra Computing

    CERN Document Server

    Corrochano, Eduardo Bayro

    2010-01-01

    This book presents contributions from a global selection of experts in the field. This useful text offers new insights and solutions for the development of theorems, algorithms and advanced methods for real-time applications across a range of disciplines. Written in an accessible style, the discussion of all applications is enhanced by the inclusion of numerous examples, figures and experimental analysis. Features: provides a thorough discussion of several tasks for image processing, pattern recognition, computer vision, robotics and computer graphics using the geometric algebra framework; int

  9. Differential Hopf algebra structures on the Universal Enveloping Algebra of a Lie Algebra

    NARCIS (Netherlands)

    van den Hijligenberg, N.W.; van den Hijligenberg, N.; Martini, Ruud

    1995-01-01

    We discuss a method to construct a De Rham complex (differential algebra) of Poincaré–Birkhoff–Witt type on the universal enveloping algebra of a Lie algebra g. We determine the cases in which this gives rise to a differential Hopf algebra that naturally extends the Hopf algebrastructure of U(g).

  10. 2-Local derivations on matrix algebras over semi-prime Banach algebras and on AW*-algebras

    International Nuclear Information System (INIS)

    Ayupov, Shavkat; Kudaybergenov, Karimbergen

    2016-01-01

    The paper is devoted to 2-local derivations on matrix algebras over unital semi-prime Banach algebras. For a unital semi-prime Banach algebra A with the inner derivation property we prove that any 2-local derivation on the algebra M 2 n (A), n ≥ 2, is a derivation. We apply this result to AW*-algebras and show that any 2-local derivation on an arbitrary AW*-algebra is a derivation. (paper)

  11. A Parallel Multigrid Solver for Viscous Flows on Anisotropic Structured Grids

    Science.gov (United States)

    Prieto, Manuel; Montero, Ruben S.; Llorente, Ignacio M.; Bushnell, Dennis M. (Technical Monitor)

    2001-01-01

    This paper presents an efficient parallel multigrid solver for speeding up the computation of a 3-D model that treats the flow of a viscous fluid over a flat plate. The main interest of this simulation lies in exhibiting some basic difficulties that prevent optimal multigrid efficiencies from being achieved. As the computing platform, we have used Coral, a Beowulf-class system based on Intel Pentium processors and equipped with GigaNet cLAN and switched Fast Ethernet networks. Our study not only examines the scalability of the solver but also includes a performance evaluation of Coral where the investigated solver has been used to compare several of its design choices, namely, the interconnection network (GigaNet versus switched Fast-Ethernet) and the node configuration (dual nodes versus single nodes). As a reference, the performance results have been compared with those obtained with the NAS-MG benchmark.

  12. Quantum cluster algebra structures on quantum nilpotent algebras

    CERN Document Server

    Goodearl, K R

    2017-01-01

    All algebras in a very large, axiomatically defined class of quantum nilpotent algebras are proved to possess quantum cluster algebra structures under mild conditions. Furthermore, it is shown that these quantum cluster algebras always equal the corresponding upper quantum cluster algebras. Previous approaches to these problems for the construction of (quantum) cluster algebra structures on (quantized) coordinate rings arising in Lie theory were done on a case by case basis relying on the combinatorics of each concrete family. The results of the paper have a broad range of applications to these problems, including the construction of quantum cluster algebra structures on quantum unipotent groups and quantum double Bruhat cells (the Berenstein-Zelevinsky conjecture), and treat these problems from a unified perspective. All such applications also establish equality between the constructed quantum cluster algebras and their upper counterparts.

  13. Real-Time Algebraic Derivative Estimations Using a Novel Low-Cost Architecture Based on Reconfigurable Logic

    Science.gov (United States)

    Morales, Rafael; Rincón, Fernando; Gazzano, Julio Dondo; López, Juan Carlos

    2014-01-01

    Time derivative estimation of signals plays a very important role in several fields, such as signal processing and control engineering, just to name a few of them. For that purpose, a non-asymptotic algebraic procedure for the approximate estimation of the system states is used in this work. The method is based on results from differential algebra and furnishes some general formulae for the time derivatives of a measurable signal in which two algebraic derivative estimators run simultaneously, but in an overlapping fashion. The algebraic derivative algorithm presented in this paper is computed online and in real-time, offering high robustness properties with regard to corrupting noises, versatility and ease of implementation. Besides, in this work, we introduce a novel architecture to accelerate this algebraic derivative estimator using reconfigurable logic. The core of the algorithm is implemented in an FPGA, improving the speed of the system and achieving real-time performance. Finally, this work proposes a low-cost platform for the integration of hardware in the loop in MATLAB. PMID:24859033

  14. Quadratic algebras

    CERN Document Server

    Polishchuk, Alexander

    2005-01-01

    Quadratic algebras, i.e., algebras defined by quadratic relations, often occur in various areas of mathematics. One of the main problems in the study of these (and similarly defined) algebras is how to control their size. A central notion in solving this problem is the notion of a Koszul algebra, which was introduced in 1970 by S. Priddy and then appeared in many areas of mathematics, such as algebraic geometry, representation theory, noncommutative geometry, K-theory, number theory, and noncommutative linear algebra. The book offers a coherent exposition of the theory of quadratic and Koszul algebras, including various definitions of Koszulness, duality theory, Poincar�-Birkhoff-Witt-type theorems for Koszul algebras, and the Koszul deformation principle. In the concluding chapter of the book, they explain a surprising connection between Koszul algebras and one-dependent discrete-time stochastic processes.

  15. Regularity of C*-algebras and central sequence algebras

    DEFF Research Database (Denmark)

    Christensen, Martin S.

    The main topic of this thesis is regularity properties of C*-algebras and how these regularity properties are re ected in their associated central sequence algebras. The thesis consists of an introduction followed by four papers [A], [B], [C], [D]. In [A], we show that for the class of simple...... Villadsen algebra of either the rst type with seed space a nite dimensional CW complex, or the second type, tensorial absorption of the Jiang-Su algebra is characterized by the absence of characters on the central sequence algebra. Additionally, in a joint appendix with Joan Bosa, we show that the Villadsen...... algebra of the second type with innite stable rank fails the corona factorization property. In [B], we consider the class of separable C*-algebras which do not admit characters on their central sequence algebra, and show that it has nice permanence properties. We also introduce a new divisibility property...

  16. Real division algebras and other algebras motivated by physics

    International Nuclear Information System (INIS)

    Benkart, G.; Osborn, J.M.

    1981-01-01

    In this survey we discuss several general techniques which have been productive in the study of real division algebras, flexible Lie-admissible algebras, and other nonassociative algebras, and we summarize results obtained using these methods. The principal method involved in this work is to view an algebra A as a module for a semisimple Lie algebra of derivations of A and to use representation theory to study products in A. In the case of real division algebras, we also discuss the use of isotopy and the use of a generalized Peirce decomposition. Most of the work summarized here has appeared in more detail in various other papers. The exceptions are results on a class of algebras of dimension 15, motivated by physics, which admit the Lie algebra sl(3) as an algebra of derivations

  17. Matlab linear algebra

    CERN Document Server

    Lopez, Cesar

    2014-01-01

    MATLAB is a high-level language and environment for numerical computation, visualization, and programming. Using MATLAB, you can analyze data, develop algorithms, and create models and applications. The language, tools, and built-in math functions enable you to explore multiple approaches and reach a solution faster than with spreadsheets or traditional programming languages, such as C/C++ or Java. MATLAB Linear Algebra introduces you to the MATLAB language with practical hands-on instructions and results, allowing you to quickly achieve your goals. In addition to giving an introduction to

  18. Investigating the use of interval algebra to schedule mechanically steered multistatic radars

    CSIR Research Space (South Africa)

    Focke, RW

    2015-02-01

    Full Text Available to test random target locations and motion. A novel IA algorithm that makes use of reduced point algebra was generated that allowed execution time to be reduced. Another, simpler novel contribution was an IA algorithm that ensured that radar tasks are only...

  19. Reconstruction of an InAs nanowire using geometric and algebraic tomography

    International Nuclear Information System (INIS)

    Pennington, R S; Boothroyd, C B; König, S; Alpers, A; Dunin-Borkowski, R E

    2011-01-01

    Geometric tomography and conventional algebraic tomography algorithms are used to reconstruct cross-sections of an InAs nanowire from a tilt series of experimental annular dark-field images. Both algorithms are also applied to a test object to assess what factors affect the reconstruction quality. When using the present algorithms, geometric tomography is faster, but artifacts in the reconstruction may be difficult to recognize.

  20. Reconstruction of an InAs nanowire using geometric and algebraic tomography

    DEFF Research Database (Denmark)

    Pennington, Robert S.; König, S.; Alpers, A.

    2011-01-01

    Geometric tomography and conventional algebraic tomography algorithms are used to reconstruct cross-sections of an InAs nanowire from a tilt series of experimental annular dark-field images. Both algorithms are also applied to a test object to assess what factors affect the reconstruction quality....... When using the present algorithms, geometric tomography is faster, but artifacts in the reconstruction may be difficult to recognize....

  1. Hom-Novikov algebras

    International Nuclear Information System (INIS)

    Yau, Donald

    2011-01-01

    We study a twisted generalization of Novikov algebras, called Hom-Novikov algebras, in which the two defining identities are twisted by a linear map. It is shown that Hom-Novikov algebras can be obtained from Novikov algebras by twisting along any algebra endomorphism. All algebra endomorphisms on complex Novikov algebras of dimensions 2 or 3 are computed, and their associated Hom-Novikov algebras are described explicitly. Another class of Hom-Novikov algebras is constructed from Hom-commutative algebras together with a derivation, generalizing a construction due to Dorfman and Gel'fand. Two other classes of Hom-Novikov algebras are constructed from Hom-Lie algebras together with a suitable linear endomorphism, generalizing a construction due to Bai and Meng.

  2. Linear algebra meets Lie algebra: the Kostant-Wallach theory

    OpenAIRE

    Shomron, Noam; Parlett, Beresford N.

    2008-01-01

    In two languages, Linear Algebra and Lie Algebra, we describe the results of Kostant and Wallach on the fibre of matrices with prescribed eigenvalues of all leading principal submatrices. In addition, we present a brief introduction to basic notions in Algebraic Geometry, Integrable Systems, and Lie Algebra aimed at specialists in Linear Algebra.

  3. Multilevel local refinement and multigrid methods for 3-D turbulent flow

    Energy Technology Data Exchange (ETDEWEB)

    Liao, C.; Liu, C. [UCD, Denver, CO (United States); Sung, C.H.; Huang, T.T. [David Taylor Model Basin, Bethesda, MD (United States)

    1996-12-31

    A numerical approach based on multigrid, multilevel local refinement, and preconditioning methods for solving incompressible Reynolds-averaged Navier-Stokes equations is presented. 3-D turbulent flow around an underwater vehicle is computed. 3 multigrid levels and 2 local refinement grid levels are used. The global grid is 24 x 8 x 12. The first patch is 40 x 16 x 20 and the second patch is 72 x 32 x 36. 4th order artificial dissipation are used for numerical stability. The conservative artificial compressibility method are used for further improvement of convergence. To improve the accuracy of coarse/fine grid interface of local refinement, flux interpolation method for refined grid boundary is used. The numerical results are in good agreement with experimental data. The local refinement can improve the prediction accuracy significantly. The flux interpolation method for local refinement can keep conservation for a composite grid, therefore further modify the prediction accuracy.

  4. Multigrid solution of the Navier-Stokes equations at low speeds with large temperature variations

    International Nuclear Information System (INIS)

    Sockol, Peter M.

    2003-01-01

    Multigrid methods for the Navier-Stokes equations at low speeds and large temperature variations are investigated. The compressible equations with time-derivative preconditioning and preconditioned flux-difference splitting of the inviscid terms are used. Three implicit smoothers have been incorporated into a common multigrid procedure. Both full coarsening and semi-coarsening with directional fine-grid defect correction have been studied. The resulting methods have been tested on four 2D laminar problems over a range of Reynolds numbers on both uniform and highly stretched grids. Two of the three methods show efficient and robust performance over the entire range of conditions. In addition, none of the methods has any difficulty with the large temperature variations

  5. A Linear Algebra Measure of Cluster Quality.

    Science.gov (United States)

    Mather, Laura A.

    2000-01-01

    Discussion of models for information retrieval focuses on an application of linear algebra to text clustering, namely, a metric for measuring cluster quality based on the theory that cluster quality is proportional to the number of terms that are disjoint across the clusters. Explains term-document matrices and clustering algorithms. (Author/LRW)

  6. Equivalent construction of the infinitesimal time translation operator in algebraic dynamics algorithm for partial differential evolution equation

    Institute of Scientific and Technical Information of China (English)

    2010-01-01

    We give an equivalent construction of the infinitesimal time translation operator for partial differential evolution equation in the algebraic dynamics algorithm proposed by Shun-Jin Wang and his students. Our construction involves only simple partial differentials and avoids the derivative terms of δ function which appear in the course of computation by means of Wang-Zhang operator. We prove Wang’s equivalent theorem which says that our construction and Wang-Zhang’s are equivalent. We use our construction to deal with several typical equations such as nonlinear advection equation, Burgers equation, nonlinear Schrodinger equation, KdV equation and sine-Gordon equation, and obtain at least second order approximate solutions to them. These equations include the cases of real and complex field variables and the cases of the first and the second order time derivatives.

  7. Numerical linear algebra on emerging architectures: The PLASMA and MAGMA projects

    International Nuclear Information System (INIS)

    Agullo, Emmanuel; Demmel, Jim; Dongarra, Jack; Hadri, Bilel; Kurzak, Jakub; Langou, Julien; Ltaief, Hatem; Luszczek, Piotr; Tomov, Stanimire

    2009-01-01

    The emergence and continuing use of multi-core architectures and graphics processing units require changes in the existing software and sometimes even a redesign of the established algorithms in order to take advantage of now prevailing parallelism. Parallel Linear Algebra for Scalable Multi-core Architectures (PLASMA) and Matrix Algebra on GPU and Multics Architectures (MAGMA) are two projects that aims to achieve high performance and portability across a wide range of multi-core architectures and hybrid systems respectively. We present in this document a comparative study of PLASMA's performance against established linear algebra packages and some preliminary results of MAGMA on hybrid multi-core and GPU systems.

  8. Extended Virasoro algebra and algebra of area preserving diffeomorphisms

    International Nuclear Information System (INIS)

    Arakelyan, T.A.

    1990-01-01

    The algebra of area preserving diffeomorphism plays an important role in the theory of relativistic membranes. It is pointed out that the relation between this algebra and the extended Virasoro algebra associated with the generalized Kac-Moody algebras G(T 2 ). The highest weight representation of these infinite-dimensional algebras as well as of their subalgebras is studied. 5 refs

  9. Solving algebraic computational problems in geodesy and geoinformatics the answer to modern challenges

    CERN Document Server

    Awange, Joseph L

    2004-01-01

    While preparing and teaching 'Introduction to Geodesy I and II' to - dergraduate students at Stuttgart University, we noticed a gap which motivated the writing of the present book: Almost every topic that we taughtrequiredsomeskillsinalgebra,andinparticular,computeral- bra! From positioning to transformation problems inherent in geodesy and geoinformatics, knowledge of algebra and application of computer algebra software were required. In preparing this book therefore, we haveattemptedtoputtogetherbasicconceptsofabstractalgebra which underpin the techniques for solving algebraic problems. Algebraic c- putational algorithms useful for solving problems which require exact solutions to nonlinear systems of equations are presented and tested on various problems. Though the present book focuses mainly on the two ?elds,theconceptsand techniquespresented hereinarenonetheless- plicable to other ?elds where algebraic computational problems might be encountered. In Engineering for example, network densi?cation and robo...

  10. An application of the division algebras, Jordan algebras and split composition algebras

    International Nuclear Information System (INIS)

    Foot, R.; Joshi, G.C.

    1992-01-01

    It has been established that the covering group of the Lorentz group in D = 3, 4, 6, 10 can be expressed in a unified way, based on the four composition division algebras R, C, Q and O. In this paper, the authors discuss, in this framework, the role of the complex numbers of quantum mechanics. A unified treatment of quantum-mechanical spinors is given. The authors provide an explicit demonstration that the vector and spinor transformations recently constructed from a subgroup of the reduced structure group of the Jordan algebras M n 3 are indeed the Lorentz transformations. The authors also show that if the division algebras in the construction of the covering groups of the Lorentz groups in D = 3, 4, 6, 10 are replaced by the split composition algebras, then the sequence of groups SO(2, 2), SO(3, 3) and SO(5, 5) result. The analysis is presumed to be self-contained as the relevant aspects of the division algebras and Jordan algebras are reviewed. Some applications to physical theory are indicated

  11. Interactions Between Representation Ttheory, Algebraic Topology and Commutative Algebra

    CERN Document Server

    Pitsch, Wolfgang; Zarzuela, Santiago

    2016-01-01

    This book includes 33 expanded abstracts of selected talks given at the two workshops "Homological Bonds Between Commutative Algebra and Representation Theory" and "Brave New Algebra: Opening Perspectives," and the conference "Opening Perspectives in Algebra, Representations, and Topology," held at the Centre de Recerca Matemàtica (CRM) in Barcelona between January and June 2015. These activities were part of the one-semester intensive research program "Interactions Between Representation Theory, Algebraic Topology and Commutative Algebra (IRTATCA)." Most of the abstracts present preliminary versions of not-yet published results and cover a large number of topics (including commutative and non commutative algebra, algebraic topology, singularity theory, triangulated categories, representation theory) overlapping with homological methods. This comprehensive book is a valuable resource for the community of researchers interested in homological algebra in a broad sense, and those curious to learn the latest dev...

  12. Teaching the "Diagonalization Concept" in Linear Algebra with Technology: A Case Study at Galatasaray University

    Science.gov (United States)

    Yildiz Ulus, Aysegul

    2013-01-01

    This paper examines experimental and algorithmic contributions of advanced calculators (graphing and computer algebra system, CAS) in teaching the concept of "diagonalization," one of the key topics in Linear Algebra courses taught at the undergraduate level. Specifically, the proposed hypothesis of this study is to assess the effective…

  13. Duncan F. Gregory, William Walton and the development of British algebra: 'algebraical geometry', 'geometrical algebra', abstraction.

    Science.gov (United States)

    Verburgt, Lukas M

    2016-01-01

    This paper provides a detailed account of the period of the complex history of British algebra and geometry between the publication of George Peacock's Treatise on Algebra in 1830 and William Rowan Hamilton's paper on quaternions of 1843. During these years, Duncan Farquharson Gregory and William Walton published several contributions on 'algebraical geometry' and 'geometrical algebra' in the Cambridge Mathematical Journal. These contributions enabled them not only to generalize Peacock's symbolical algebra on the basis of geometrical considerations, but also to initiate the attempts to question the status of Euclidean space as the arbiter of valid geometrical interpretations. At the same time, Gregory and Walton were bound by the limits of symbolical algebra that they themselves made explicit; their work was not and could not be the 'abstract algebra' and 'abstract geometry' of figures such as Hamilton and Cayley. The central argument of the paper is that an understanding of the contributions to 'algebraical geometry' and 'geometrical algebra' of the second generation of 'scientific' symbolical algebraists is essential for a satisfactory explanation of the radical transition from symbolical to abstract algebra that took place in British mathematics in the 1830s-1840s.

  14. Two-level Fourier analysis of a multigrid approach for discontinuous Galerkin discretisation

    NARCIS (Netherlands)

    P.W. Hemker (Piet); W. Hoffmann; M.H. van Raalte (Marc)

    2002-01-01

    textabstractIn this paper we study a multigrid method for the solution of a linear second order elliptic equation, discretized by discontinuous Galerkin (DG) methods, andwe give a detailed analysis of the convergence for different block-relaxation strategies.We find that point-wise

  15. Monomial algebras

    CERN Document Server

    Villarreal, Rafael

    2015-01-01

    The book stresses the interplay between several areas of pure and applied mathematics, emphasizing the central role of monomial algebras. It unifies the classical results of commutative algebra with central results and notions from graph theory, combinatorics, linear algebra, integer programming, and combinatorial optimization. The book introduces various methods to study monomial algebras and their presentation ideals, including Stanley-Reisner rings, subrings and blowup algebra-emphasizing square free quadratics, hypergraph clutters, and effective computational methods.

  16. El desempeño del docente en el proceso de desarrollo de habilidades de trabajo con algoritmos en la disciplina Álgebra Lineal / Teachers' performance and the process of developing skills to work with algorithms in Linear Algebra

    Directory of Open Access Journals (Sweden)

    Ivonne Burguet Lago

    2018-05-01

    Full Text Available ABSTRACT The paper describes a proposal of professional pedagogical performance tests to assess teachers’ role in the process of developing the skill of working with algorithms in Linear Algebra. It aims at devising a testing tool to assess teachers’ performance in the skill-developing process. This tool is a finding of Cuba theory of Advanced Education, systematically used in recent years. The findings include the test design and the illustration of its use in a sample of 22 Linear Algebra teachers during the first term of the 2017-2018 academic year at Informatics Sciences Engineering major. Keywords: ABSTRACT The paper describes a proposal of professional pedagogical performance tests to assess teachers’ role in the process of developing the skill of working with algorithms in Linear Algebra. It aims at devising a testing tool to assess teachers’ performance in the skill-developing process. This tool is a finding of Cuba theory of Advanced Education, systematically used in recent years. The findings include the test design and the illustration of its use in a sample of 22 Linear Algebra teachers during the first term of the 2017-2018 academic year at Informatics Sciences Engineering major.

  17. Algebra

    CERN Document Server

    Tabak, John

    2004-01-01

    Looking closely at algebra, its historical development, and its many useful applications, Algebra examines in detail the question of why this type of math is so important that it arose in different cultures at different times. The book also discusses the relationship between algebra and geometry, shows the progress of thought throughout the centuries, and offers biographical data on the key figures. Concise and comprehensive text accompanied by many illustrations presents the ideas and historical development of algebra, showcasing the relevance and evolution of this branch of mathematics.

  18. Iwahori-Hecke algebras and Schur algebras of the symmetric group

    CERN Document Server

    Mathas, Andrew

    1999-01-01

    This volume presents a fully self-contained introduction to the modular representation theory of the Iwahori-Hecke algebras of the symmetric groups and of the q-Schur algebras. The study of these algebras was pioneered by Dipper and James in a series of landmark papers. The primary goal of the book is to classify the blocks and the simple modules of both algebras. The final chapter contains a survey of recent advances and open problems. The main results are proved by showing that the Iwahori-Hecke algebras and q-Schur algebras are cellular algebras (in the sense of Graham and Lehrer). This is proved by exhibiting natural bases of both algebras which are indexed by pairs of standard and semistandard tableaux respectively. Using the machinery of cellular algebras, which is developed in Chapter 2, this results in a clean and elegant classification of the irreducible representations of both algebras. The block theory is approached by first proving an analogue of the Jantzen sum formula for the q-Schur algebras. T...

  19. Algebra of pseudo-differential operators over C*-algebra

    International Nuclear Information System (INIS)

    Mohammad, N.

    1982-08-01

    Algebras of pseudo-differential operators over C*-algebras are studied for the special case when in Hormander class Ssub(rho,delta)sup(m)(Ω) Ω = Rsup(n); rho = 1, delta = 0, m any real number, and the C*-algebra is infinite dimensional non-commutative. The space B, i.e. the set of A-valued C*-functions in Rsup(n) (or Rsup(n) x Rsup(n)) whose derivatives are all bounded, plays an important role. A denotes C*-algebra. First the operator class Ssub(phi,0)sup(m) is defined, and through it, the class Lsub(1,0)sup(m) of pseudo-differential operators. Then the basic asymptotic expansion theorems concerning adjoint and product of operators of class Ssub(1,0)sup(m) are stated. Finally, proofs are given of L 2 -continuity theorem and the main theorem, which states that algebra of all pseudo-differential operators over C*-algebras is itself C*-algebra

  20. Commutative algebra with a view toward algebraic geometry

    CERN Document Server

    Eisenbud, David

    1995-01-01

    Commutative Algebra is best understood with knowledge of the geometric ideas that have played a great role in its formation, in short, with a view towards algebraic geometry. The author presents a comprehensive view of commutative algebra, from basics, such as localization and primary decomposition, through dimension theory, differentials, homological methods, free resolutions and duality, emphasizing the origins of the ideas and their connections with other parts of mathematics. Many exercises illustrate and sharpen the theory and extended exercises give the reader an active part in complementing the material presented in the text. One novel feature is a chapter devoted to a quick but thorough treatment of Grobner basis theory and the constructive methods in commutative algebra and algebraic geometry that flow from it. Applications of the theory and even suggestions for computer algebra projects are included. This book will appeal to readers from beginners to advanced students of commutative algebra or algeb...

  1. Jordan algebras versus C*- algebras

    International Nuclear Information System (INIS)

    Stormer, E.

    1976-01-01

    The axiomatic formulation of quantum mechanics and the problem of whether the observables form self-adjoint operators on a Hilbert space, are discussed. The relation between C*- algebras and Jordan algebras is studied using spectral theory. (P.D.)

  2. Algebraic Reconstruction of Current Dipoles and Quadrupoles in Three-Dimensional Space

    Directory of Open Access Journals (Sweden)

    Takaaki Nara

    2013-01-01

    Full Text Available This paper presents an algebraic method for an inverse source problem for the Poisson equation where the source consists of dipoles and quadrupoles. This source model is significant in the magnetoencephalography inverse problem. The proposed method identifies the source parameters directly and algebraically using data without requiring an initial parameter estimate or iterative computation of the forward solution. The obtained parameters could be used for the initial solution in an optimization-based algorithm for further refinement.

  3. Algorithmic mathematics

    CERN Document Server

    Hougardy, Stefan

    2016-01-01

    Algorithms play an increasingly important role in nearly all fields of mathematics. This book allows readers to develop basic mathematical abilities, in particular those concerning the design and analysis of algorithms as well as their implementation. It presents not only fundamental algorithms like the sieve of Eratosthenes, the Euclidean algorithm, sorting algorithms, algorithms on graphs, and Gaussian elimination, but also discusses elementary data structures, basic graph theory, and numerical questions. In addition, it provides an introduction to programming and demonstrates in detail how to implement algorithms in C++. This textbook is suitable for students who are new to the subject and covers a basic mathematical lecture course, complementing traditional courses on analysis and linear algebra. Both authors have given this "Algorithmic Mathematics" course at the University of Bonn several times in recent years.

  4. Local multigrid mesh refinement in view of nuclear fuel 3D modelling in pressurised water reactors

    International Nuclear Information System (INIS)

    Barbie, L.

    2013-01-01

    The aim of this study is to improve the performances, in terms of memory space and computational time, of the current modelling of the Pellet-Cladding mechanical Interaction (PCI), complex phenomenon which may occurs during high power rises in pressurised water reactors. Among the mesh refinement methods - methods dedicated to efficiently treat local singularities - a local multi-grid approach was selected because it enables the use of a black-box solver while dealing few degrees of freedom at each level. The Local Defect Correction (LDC) method, well suited to a finite element discretization, was first analysed and checked in linear elasticity, on configurations resulting from the PCI, since its use in solid mechanics is little widespread. Various strategies concerning the implementation of the multilevel algorithm were also compared. Coupling the LDC method with the Zienkiewicz-Zhu a posteriori error estimator in order to automatically detect the zones to be refined, was then tested. Performances obtained on two-dimensional and three-dimensional cases are very satisfactory, since the algorithm proposed is more efficient than h-adaptive refinement methods. Lastly, the LDC algorithm was extended to nonlinear mechanics. Space/time refinement as well as transmission of the initial conditions during the re-meshing step were looked at. The first results obtained are encouraging and show the interest of using the LDC method for PCI modelling. (author) [fr

  5. Implicative Algebras

    African Journals Online (AJOL)

    Tadesse

    In this paper we introduce the concept of implicative algebras which is an equivalent definition of lattice implication algebra of Xu (1993) and further we prove that it is a regular Autometrized. Algebra. Further we remark that the binary operation → on lattice implicative algebra can never be associative. Key words: Implicative ...

  6. Open algebraic surfaces

    CERN Document Server

    Miyanishi, Masayoshi

    2000-01-01

    Open algebraic surfaces are a synonym for algebraic surfaces that are not necessarily complete. An open algebraic surface is understood as a Zariski open set of a projective algebraic surface. There is a long history of research on projective algebraic surfaces, and there exists a beautiful Enriques-Kodaira classification of such surfaces. The research accumulated by Ramanujan, Abhyankar, Moh, and Nagata and others has established a classification theory of open algebraic surfaces comparable to the Enriques-Kodaira theory. This research provides powerful methods to study the geometry and topology of open algebraic surfaces. The theory of open algebraic surfaces is applicable not only to algebraic geometry, but also to other fields, such as commutative algebra, invariant theory, and singularities. This book contains a comprehensive account of the theory of open algebraic surfaces, as well as several applications, in particular to the study of affine surfaces. Prerequisite to understanding the text is a basic b...

  7. An algorithm to compute the canonical basis of an irreducible Uq(g)-module

    OpenAIRE

    de Graaf, W. A.

    2002-01-01

    An algorithm is described to compute the canonical basis of an irreducible module over a quantized enveloping algebra of a finite-dimensional semisimple Lie algebra. The algorithm works for modules that are constructed as a submodule of a tensor product of modules with known canonical bases.

  8. Separable algebras

    CERN Document Server

    Ford, Timothy J

    2017-01-01

    This book presents a comprehensive introduction to the theory of separable algebras over commutative rings. After a thorough introduction to the general theory, the fundamental roles played by separable algebras are explored. For example, Azumaya algebras, the henselization of local rings, and Galois theory are rigorously introduced and treated. Interwoven throughout these applications is the important notion of étale algebras. Essential connections are drawn between the theory of separable algebras and Morita theory, the theory of faithfully flat descent, cohomology, derivations, differentials, reflexive lattices, maximal orders, and class groups. The text is accessible to graduate students who have finished a first course in algebra, and it includes necessary foundational material, useful exercises, and many nontrivial examples.

  9. Many-core graph analytics using accelerated sparse linear algebra routines

    Science.gov (United States)

    Kozacik, Stephen; Paolini, Aaron L.; Fox, Paul; Kelmelis, Eric

    2016-05-01

    Graph analytics is a key component in identifying emerging trends and threats in many real-world applications. Largescale graph analytics frameworks provide a convenient and highly-scalable platform for developing algorithms to analyze large datasets. Although conceptually scalable, these techniques exhibit poor performance on modern computational hardware. Another model of graph computation has emerged that promises improved performance and scalability by using abstract linear algebra operations as the basis for graph analysis as laid out by the GraphBLAS standard. By using sparse linear algebra as the basis, existing highly efficient algorithms can be adapted to perform computations on the graph. This approach, however, is often less intuitive to graph analytics experts, who are accustomed to vertex-centric APIs such as Giraph, GraphX, and Tinkerpop. We are developing an implementation of the high-level operations supported by these APIs in terms of linear algebra operations. This implementation is be backed by many-core implementations of the fundamental GraphBLAS operations required, and offers the advantages of both the intuitive programming model of a vertex-centric API and the performance of a sparse linear algebra implementation. This technology can reduce the number of nodes required, as well as the run-time for a graph analysis problem, enabling customers to perform more complex analysis with less hardware at lower cost. All of this can be accomplished without the requirement for the customer to make any changes to their analytics code, thanks to the compatibility with existing graph APIs.

  10. On one method of realization of commutation relation algebra

    International Nuclear Information System (INIS)

    Sveshnikov, K.A.

    1983-01-01

    Method for constructing the commulation relation representations based on the purely algebraic construction of joined algebraic representation with specially selected composition law has been suggested9 Purely combinatorial construction realizing commulation relations representation has been obtained proceeding from formal equivalence of operatopr action on vector and adding a simbol to a sequences of symbols. The above method practically has the structure of calculating algorithm, which assigns some rule of ''word'' formation of an initial set of ''letters''. In other words, a computer language with definite relations between words (an analogy between quantum mechanics and computer linguistics has been applied)

  11. Analysis of preconditioning and multigrid for Euler flows with low-subsonic regions

    NARCIS (Netherlands)

    Koren, B.; Leer, van B.

    1995-01-01

    For subsonic flows and upwind-discretized, linearized 1-D Euler equations, the smoothing behavior of multigrid-accelerated point Gauss-Seidel relaxation is analyzed. Error decay by convection across domain boundaries is also discussed. A fix to poor convergence rates at low Mach numbers is sought in

  12. Generalized EMV-Effect Algebras

    Science.gov (United States)

    Borzooei, R. A.; Dvurečenskij, A.; Sharafi, A. H.

    2018-04-01

    Recently in Dvurečenskij and Zahiri (2017), new algebraic structures, called EMV-algebras which generalize both MV-algebras and generalized Boolean algebras, were introduced. We present equivalent conditions for EMV-algebras. In addition, we define a partial algebraic structure, called a generalized EMV-effect algebra, which is close to generalized MV-effect algebras. Finally, we show that every generalized EMV-effect algebra is either an MV-effect algebra or can be embedded into an MV-effect algebra as a maximal ideal.

  13. An algebraic approach to analysis of recursive and concurrent programs

    DEFF Research Database (Denmark)

    Terepeta, Michal Tomasz

    -approximation of (or induced from) another flow algebra. Furthermore, we show how flow algebras can be used in communicating or weighted pushdown systems. To achieve that, we show that it is possible to relax some of the requirements imposed by original formulation of those techniques without compromising...... such a language. We also introduce an abstract domain that symbolically represents the messages sent between the concurrently executing processes. It stores prefixes or suffixes of communication traces including various constraints imposed on the messages. Since the problem has exponential complexity, we also...... present a compact data structure as well as efficient algorithms for the semiring operations. Apart from that, we discuss an improvement to Pre* and Post* algorithms for pushdown systems, making it possible to directly use program representations such as program graphs. We present a modular library...

  14. Multigrid and defect correction for the steady Navier-Stokes equations : application to aerodynamics

    NARCIS (Netherlands)

    Koren, B.

    1991-01-01

    Theoretical and expcrimental convergence results are presented for nonlinear multigrid and iterative defect correction applied to finite volume discretizations of the full, steady, 2D, compressible NavierStokes equations. lterative defect correction is introduced for circumventing the difficulty in

  15. Compiler generation and autotuning of communication-avoiding operators for geometric multigrid

    Energy Technology Data Exchange (ETDEWEB)

    Basu, Protonu [Univ. of Utah, Salt Lake City, UT (United States); Venkat, Anand [Univ. of Utah, Salt Lake City, UT (United States); Hall, Mary [Univ. of Utah, Salt Lake City, UT (United States); Williams, Samuel [Lawrence Berkeley National Lab. (LBNL), Berkeley, CA (United States); Van Straalen, Brian [Lawrence Berkeley National Lab. (LBNL), Berkeley, CA (United States); Oliker, Leonid [Lawrence Berkeley National Lab. (LBNL), Berkeley, CA (United States)

    2014-04-17

    This paper describes a compiler approach to introducing communication-avoiding optimizations in geometric multigrid (GMG), one of the most popular methods for solving partial differential equations. Communication-avoiding optimizations reduce vertical communication through the memory hierarchy and horizontal communication across processes or threads, usually at the expense of introducing redundant computation. We focus on applying these optimizations to the smooth operator, which successively reduces the error and accounts for the largest fraction of the GMG execution time. Our compiler technology applies both novel and known transformations to derive an implementation comparable to manually-tuned code. To make the approach portable, an underlying autotuning system explores the tradeoff between reduced communication and increased computation, as well as tradeoffs in threading schemes, to automatically identify the best implementation for a particular architecture and at each computation phase. Results show that we are able to quadruple the performance of the smooth operation on the finest grids while attaining performance within 94% of manually-tuned code. Overall we improve the overall multigrid solve time by 2.5× without sacrificing programer productivity.

  16. Cellular Automaton Modeling of Dendritic Growth Using a Multi-grid Method

    International Nuclear Information System (INIS)

    Natsume, Y; Ohsasa, K

    2015-01-01

    A two-dimensional cellular automaton model with a multi-grid method was developed to simulate dendritic growth. In the present model, we used a triple-grid system for temperature, solute concentration and solid fraction fields as a new approach of the multi-grid method. In order to evaluate the validity of the present model, we carried out simulations of single dendritic growth, secondary dendrite arm growth, multi-columnar dendritic growth and multi-equiaxed dendritic growth. From the results of the grid dependency from the simulation of single dendritic growth, we confirmed that the larger grid can be used in the simulation and that the computational time can be reduced dramatically. In the simulation of secondary dendrite arm growth, the results from the present model were in good agreement with the experimental data and the simulated results from a phase-field model. Thus, the present model can quantitatively simulate dendritic growth. From the simulated results of multi-columnar and multi-equiaxed dendrites, we confirmed that the present model can perform simulations under practical solidification conditions. (paper)

  17. Special set linear algebra and special set fuzzy linear algebra

    OpenAIRE

    Kandasamy, W. B. Vasantha; Smarandache, Florentin; Ilanthenral, K.

    2009-01-01

    The authors in this book introduce the notion of special set linear algebra and special set fuzzy Linear algebra, which is an extension of the notion set linear algebra and set fuzzy linear algebra. These concepts are best suited in the application of multi expert models and cryptology. This book has five chapters. In chapter one the basic concepts about set linear algebra is given in order to make this book a self contained one. The notion of special set linear algebra and their fuzzy analog...

  18. ADAM: analysis of discrete models of biological systems using computer algebra.

    Science.gov (United States)

    Hinkelmann, Franziska; Brandon, Madison; Guang, Bonny; McNeill, Rustin; Blekherman, Grigoriy; Veliz-Cuba, Alan; Laubenbacher, Reinhard

    2011-07-20

    Many biological systems are modeled qualitatively with discrete models, such as probabilistic Boolean networks, logical models, Petri nets, and agent-based models, to gain a better understanding of them. The computational complexity to analyze the complete dynamics of these models grows exponentially in the number of variables, which impedes working with complex models. There exist software tools to analyze discrete models, but they either lack the algorithmic functionality to analyze complex models deterministically or they are inaccessible to many users as they require understanding the underlying algorithm and implementation, do not have a graphical user interface, or are hard to install. Efficient analysis methods that are accessible to modelers and easy to use are needed. We propose a method for efficiently identifying attractors and introduce the web-based tool Analysis of Dynamic Algebraic Models (ADAM), which provides this and other analysis methods for discrete models. ADAM converts several discrete model types automatically into polynomial dynamical systems and analyzes their dynamics using tools from computer algebra. Specifically, we propose a method to identify attractors of a discrete model that is equivalent to solving a system of polynomial equations, a long-studied problem in computer algebra. Based on extensive experimentation with both discrete models arising in systems biology and randomly generated networks, we found that the algebraic algorithms presented in this manuscript are fast for systems with the structure maintained by most biological systems, namely sparseness and robustness. For a large set of published complex discrete models, ADAM identified the attractors in less than one second. Discrete modeling techniques are a useful tool for analyzing complex biological systems and there is a need in the biological community for accessible efficient analysis tools. ADAM provides analysis methods based on mathematical algorithms as a web

  19. A first-order multigrid method for bound-constrained convex optimization

    Czech Academy of Sciences Publication Activity Database

    Kočvara, Michal; Mohammed, S.

    2016-01-01

    Roč. 31, č. 3 (2016), s. 622-644 ISSN 1055-6788 R&D Projects: GA ČR(CZ) GAP201/12/0671 Grant - others:European Commission - EC(XE) 313781 Institutional support: RVO:67985556 Keywords : bound-constrained optimization * multigrid methods * linear complementarity problems Subject RIV: BA - General Mathematics Impact factor: 1.023, year: 2016 http://library.utia.cas.cz/separaty/2016/MTR/kocvara-0460326.pdf

  20. Banach Synaptic Algebras

    Science.gov (United States)

    Foulis, David J.; Pulmannov, Sylvia

    2018-04-01

    Using a representation theorem of Erik Alfsen, Frederic Schultz, and Erling Størmer for special JB-algebras, we prove that a synaptic algebra is norm complete (i.e., Banach) if and only if it is isomorphic to the self-adjoint part of a Rickart C∗-algebra. Also, we give conditions on a Banach synaptic algebra that are equivalent to the condition that it is isomorphic to the self-adjoint part of an AW∗-algebra. Moreover, we study some relationships between synaptic algebras and so-called generalized Hermitian algebras.

  1. Parallel algorithms for network routing problems and recurrences

    International Nuclear Information System (INIS)

    Wisniewski, J.A.; Sameh, A.H.

    1982-01-01

    In this paper, we consider the parallel solution of recurrences, and linear systems in the regular algebra of Carre. These problems are equivalent to solving the shortest path problem in graph theory, and they also arise in the analysis of Fortran programs. Our methods for solving linear systems in the regular algebra are analogues of well-known methods for solving systems of linear algebraic equations. A parallel version of Dijkstra's method, which has no linear algebraic analogue, is presented. Considerations for choosing an algorithm when the problem is large and sparse are also discussed

  2. Grassmann algebras

    International Nuclear Information System (INIS)

    Garcia, R.L.

    1983-11-01

    The Grassmann algebra is presented briefly. Exponential and logarithm of matrices functions, whose elements belong to this algebra, are studied with the help of the SCHOONSCHIP and REDUCE 2 algebraic manipulators. (Author) [pt

  3. Algorithmic Verification of Linearizability for Ordinary Differential Equations

    KAUST Repository

    Lyakhov, Dmitry A.

    2017-07-19

    For a nonlinear ordinary differential equation solved with respect to the highest order derivative and rational in the other derivatives and in the independent variable, we devise two algorithms to check if the equation can be reduced to a linear one by a point transformation of the dependent and independent variables. The first algorithm is based on a construction of the Lie point symmetry algebra and on the computation of its derived algebra. The second algorithm exploits the differential Thomas decomposition and allows not only to test the linearizability, but also to generate a system of nonlinear partial differential equations that determines the point transformation and the coefficients of the linearized equation. The implementation of both algorithms is discussed and their application is illustrated using several examples.

  4. SAGA advances in ShApes, Geometry, and Algebra : results from the Marie Curie initial training network

    CERN Document Server

    Muntingh, Georg

    2014-01-01

    This book summarizes research carried out in workshops of the SAGA project, an Initial Training Network exploring the interplay of Shapes, Algebra, Geometry and Algorithms. Written by a combination of young and experienced researchers, the book introduces new ideas in an established context. Among the central topics are approximate and sparse implicitization and surface parametrization; algebraic tools for geometric computing; algebraic geometry for computer aided design applications and problems with industrial applications. Readers will encounter new methods for the (approximate) transition between the implicit and parametric representation; new algebraic tools for geometric computing; new applications of isogeometric analysis, and will gain insight into the emerging research field situated between algebraic geometry and computer aided geometric design.

  5. Algebraic geometry

    CERN Document Server

    Lefschetz, Solomon

    2005-01-01

    An introduction to algebraic geometry and a bridge between its analytical-topological and algebraical aspects, this text for advanced undergraduate students is particularly relevant to those more familiar with analysis than algebra. 1953 edition.

  6. Converting nested algebra expressions into flat algebra expressions

    NARCIS (Netherlands)

    Paredaens, J.; Van Gucht, D.

    1992-01-01

    Nested relations generalize ordinary flat relations by allowing tuple values to be either atomic or set valued. The nested algebra is a generalization of the flat relational algebra to manipulate nested relations. In this paper we study the expressive power of the nested algebra relative to its

  7. Multigrid methods for fully implicit oil reservoir simulation

    Energy Technology Data Exchange (ETDEWEB)

    Molenaar, J.

    1995-12-31

    In this paper, the authors consider the simultaneous flow of oil and water in reservoir rock. This displacement process is modeled by two basic equations the material balance or continuity equations, and the equation of motion (Darcy`s law). For the numerical solution of this system of nonlinear partial differential equations, there are two approaches: the fully implicit or simultaneous solution method, and the sequential solution method. In this paper, the authors consider the possibility of applying multigrid methods for the iterative solution of the systems of nonlinear equations.

  8. Fibered F-Algebra

    OpenAIRE

    Kleyn, Aleks

    2007-01-01

    The concept of F-algebra and its representation can be extended to an arbitrary bundle. We define operations of fibered F-algebra in fiber. The paper presents the representation theory of of fibered F-algebra as well as a comparison of representation of F-algebra and of representation of fibered F-algebra.

  9. An implementation of Kovacic's algorithm for solving ordinary differential equations in FORMAC

    International Nuclear Information System (INIS)

    Zharkov, A.Yu.

    1987-01-01

    An implementation of Kovacic's algorithm for finding Liouvillian solutions of the differential equations y'' + a(x)y' + b(x)y = 0 with rational coefficients a(x) and b(x) in the Computer Algebra System FORMAC is described. The algorithm description is presented in such a way that one can easily implement it in a suitable Computer Algebra System

  10. The bubble algebra: structure of a two-colour Temperley-Lieb Algebra

    International Nuclear Information System (INIS)

    Grimm, Uwe; Martin, Paul P

    2003-01-01

    We define new diagram algebras providing a sequence of multiparameter generalizations of the Temperley-Lieb algebra, suitable for the modelling of dilute lattice systems of two-dimensional statistical mechanics. These algebras give a rigorous foundation to the various 'multi-colour algebras' of Grimm, Pearce and others. We determine the generic representation theory of the simplest of these algebras, and locate the nongeneric cases (at roots of unity of the corresponding parameters). We show by this example how the method used (Martin's general procedure for diagram algebras) may be applied to a wide variety of such algebras occurring in statistical mechanics. We demonstrate how these algebras may be used to solve the Yang-Baxter equations

  11. Multigrid Methods for EHL Problems

    Science.gov (United States)

    Nurgat, Elyas; Berzins, Martin

    1996-01-01

    In many bearings and contacts, forces are transmitted through thin continuous fluid films which separate two contacting elements. Objects in contact are normally subjected to friction and wear which can be reduced effectively by using lubricants. If the lubricant film is sufficiently thin to prevent the opposing solids from coming into contact and carries the entire load, then we have hydrodynamic lubrication, where the lubricant film is determined by the motion and geometry of the solids. However, for loaded contacts of low geometrical conformity, such as gears, rolling contact bearings and cams, this is not the case due to high pressures and this is referred to as Elasto-Hydrodynamic Lubrication (EHL) In EHL, elastic deformation of the contacting elements and the increase in fluid viscosity with pressure are very significant and cannot be ignored. Since the deformation results in changing the geometry of the lubricating film, which in turn determines the pressure distribution, an EHL mathematical model must simultaneously satisfy the complex elasticity (integral) and the Reynolds lubrication (differential) equations. The nonlinear and coupled nature of the two equations makes numerical calculations computationally intensive. This is especially true for highly loaded problems found in practice. One novel feature of these problems is that the solution may exhibit sharp pressure spikes in the outlet region. To this date both finite element and finite difference methods have been used to solve EHL problems with perhaps greater emphasis on the use of the finite difference approach. In both cases, a major computational difficulty is ensuring convergence of the nonlinear equations solver to a steady state solution. Two successful methods for achieving this are direct iteration and multigrid methods. Direct iteration methods (e.g Gauss Seidel) have long been used in conjunction with finite difference discretizations on regular meshes. Perhaps one of the best examples of

  12. A novel technique to solve nonlinear higher-index Hessenberg differential-algebraic equations by Adomian decomposition method.

    Science.gov (United States)

    Benhammouda, Brahim

    2016-01-01

    Since 1980, the Adomian decomposition method (ADM) has been extensively used as a simple powerful tool that applies directly to solve different kinds of nonlinear equations including functional, differential, integro-differential and algebraic equations. However, for differential-algebraic equations (DAEs) the ADM is applied only in four earlier works. There, the DAEs are first pre-processed by some transformations like index reductions before applying the ADM. The drawback of such transformations is that they can involve complex algorithms, can be computationally expensive and may lead to non-physical solutions. The purpose of this paper is to propose a novel technique that applies the ADM directly to solve a class of nonlinear higher-index Hessenberg DAEs systems efficiently. The main advantage of this technique is that; firstly it avoids complex transformations like index reductions and leads to a simple general algorithm. Secondly, it reduces the computational work by solving only linear algebraic systems with a constant coefficient matrix at each iteration, except for the first iteration where the algebraic system is nonlinear (if the DAE is nonlinear with respect to the algebraic variable). To demonstrate the effectiveness of the proposed technique, we apply it to a nonlinear index-three Hessenberg DAEs system with nonlinear algebraic constraints. This technique is straightforward and can be programmed in Maple or Mathematica to simulate real application problems.

  13. Algebraic monoids, group embeddings, and algebraic combinatorics

    CERN Document Server

    Li, Zhenheng; Steinberg, Benjamin; Wang, Qiang

    2014-01-01

    This book contains a collection of fifteen articles and is dedicated to the sixtieth birthdays of Lex Renner and Mohan Putcha, the pioneers of the field of algebraic monoids.   Topics presented include:   v  structure and representation theory of reductive algebraic monoids v  monoid schemes and applications of monoids v  monoids related to Lie theory v  equivariant embeddings of algebraic groups v  constructions and properties of monoids from algebraic combinatorics v  endomorphism monoids induced from vector bundles v  Hodge–Newton decompositions of reductive monoids   A portion of these articles are designed to serve as a self-contained introduction to these topics, while the remaining contributions are research articles containing previously unpublished results, which are sure to become very influential for future work. Among these, for example, the important recent work of Michel Brion and Lex Renner showing that the algebraic semigroups are strongly π-regular.   Graduate students as well a...

  14. Affine.m—Mathematica package for computations in representation theory of finite-dimensional and affine Lie algebras

    Science.gov (United States)

    Nazarov, Anton

    2012-11-01

    In this paper we present Affine.m-a program for computations in representation theory of finite-dimensional and affine Lie algebras and describe implemented algorithms. The algorithms are based on the properties of weights and Weyl symmetry. Computation of weight multiplicities in irreducible and Verma modules, branching of representations and tensor product decomposition are the most important problems for us. These problems have numerous applications in physics and we provide some examples of these applications. The program is implemented in the popular computer algebra system Mathematica and works with finite-dimensional and affine Lie algebras. Catalogue identifier: AENA_v1_0 Program summary URL:http://cpc.cs.qub.ac.uk/summaries/AENB_v1_0.html Program obtainable from: CPC Program Library, Queen’s University, Belfast, UK Licensing provisions: Standard CPC licence, http://cpc.cs.qub.ac.uk/licence/licence.html No. of lines in distributed program, including test data, etc.: 24 844 No. of bytes in distributed program, including test data, etc.: 1 045 908 Distribution format: tar.gz Programming language: Mathematica. Computer: i386-i686, x86_64. Operating system: Linux, Windows, Mac OS, Solaris. RAM: 5-500 Mb Classification: 4.2, 5. Nature of problem: Representation theory of finite-dimensional Lie algebras has many applications in different branches of physics, including elementary particle physics, molecular physics, nuclear physics. Representations of affine Lie algebras appear in string theories and two-dimensional conformal field theory used for the description of critical phenomena in two-dimensional systems. Also Lie symmetries play a major role in a study of quantum integrable systems. Solution method: We work with weights and roots of finite-dimensional and affine Lie algebras and use Weyl symmetry extensively. Central problems which are the computations of weight multiplicities, branching and fusion coefficients are solved using one general recurrent

  15. Leavitt path algebras

    CERN Document Server

    Abrams, Gene; Siles Molina, Mercedes

    2017-01-01

    This book offers a comprehensive introduction by three of the leading experts in the field, collecting fundamental results and open problems in a single volume. Since Leavitt path algebras were first defined in 2005, interest in these algebras has grown substantially, with ring theorists as well as researchers working in graph C*-algebras, group theory and symbolic dynamics attracted to the topic. Providing a historical perspective on the subject, the authors review existing arguments, establish new results, and outline the major themes and ring-theoretic concepts, such as the ideal structure, Z-grading and the close link between Leavitt path algebras and graph C*-algebras. The book also presents key lines of current research, including the Algebraic Kirchberg Phillips Question, various additional classification questions, and connections to noncommutative algebraic geometry. Leavitt Path Algebras will appeal to graduate students and researchers working in the field and related areas, such as C*-algebras and...

  16. Sixth SIAM conference on applied linear algebra: Final program and abstracts. Final technical report

    Energy Technology Data Exchange (ETDEWEB)

    NONE

    1997-12-31

    Linear algebra plays a central role in mathematics and applications. The analysis and solution of problems from an amazingly wide variety of disciplines depend on the theory and computational techniques of linear algebra. In turn, the diversity of disciplines depending on linear algebra also serves to focus and shape its development. Some problems have special properties (numerical, structural) that can be exploited. Some are simply so large that conventional approaches are impractical. New computer architectures motivate new algorithms, and fresh ways to look at old ones. The pervasive nature of linear algebra in analyzing and solving problems means that people from a wide spectrum--universities, industrial and government laboratories, financial institutions, and many others--share an interest in current developments in linear algebra. This conference aims to bring them together for their mutual benefit. Abstracts of papers presented are included.

  17. Priority in Process Algebras

    Science.gov (United States)

    Cleaveland, Rance; Luettgen, Gerald; Natarajan, V.

    1999-01-01

    This paper surveys the semantic ramifications of extending traditional process algebras with notions of priority that allow for some transitions to be given precedence over others. These enriched formalisms allow one to model system features such as interrupts, prioritized choice, or real-time behavior. Approaches to priority in process algebras can be classified according to whether the induced notion of preemption on transitions is global or local and whether priorities are static or dynamic. Early work in the area concentrated on global pre-emption and static priorities and led to formalisms for modeling interrupts and aspects of real-time, such as maximal progress, in centralized computing environments. More recent research has investigated localized notions of pre-emption in which the distribution of systems is taken into account, as well as dynamic priority approaches, i.e., those where priority values may change as systems evolve. The latter allows one to model behavioral phenomena such as scheduling algorithms and also enables the efficient encoding of real-time semantics. Technically, this paper studies the different models of priorities by presenting extensions of Milner's Calculus of Communicating Systems (CCS) with static and dynamic priority as well as with notions of global and local pre- emption. In each case the operational semantics of CCS is modified appropriately, behavioral theories based on strong and weak bisimulation are given, and related approaches for different process-algebraic settings are discussed.

  18. Finding the radical of an algebra of linear transformations

    NARCIS (Netherlands)

    Cohen, A.M.; Ivanyos, G.; Wales, D.B.

    1997-01-01

    We present a method that reduces the problem of computing the radical of a matrix algebra over an arbitrary field to solving systems of semilinear equations. The complexity of the algorithm, measured in the number of arithmetic operations and the total number of the coefficients passed to an oracle

  19. Symbolic Algebra Development for Higher-Order Electron Propagator Formulation and Implementation.

    Science.gov (United States)

    Tamayo-Mendoza, Teresa; Flores-Moreno, Roberto

    2014-06-10

    Through the use of symbolic algebra, implemented in a program, the algebraic expression of the elements of the self-energy matrix for the electron propagator to different orders were obtained. In addition, a module for the software package Lowdin was automatically generated. Second- and third-order electron propagator results have been calculated to test the correct operation of the program. It was found that the Fortran 90 modules obtained automatically with our algorithm succeeded in calculating ionization energies with the second- and third-order electron propagator in the diagonal approximation. The strategy for the development of this symbolic algebra program is described in detail. This represents a solid starting point for the automatic derivation and implementation of higher-order electron propagator methods.

  20. Approximation of complex algebraic numbers by algebraic numbers of bounded degree

    OpenAIRE

    Bugeaud, Yann; Evertse, Jan-Hendrik

    2007-01-01

    We investigate how well complex algebraic numbers can be approximated by algebraic numbers of degree at most n. We also investigate how well complex algebraic numbers can be approximated by algebraic integers of degree at most n+1. It follows from our investigations that for every positive integer n there are complex algebraic numbers of degree larger than n that are better approximable by algebraic numbers of degree at most n than almost all complex numbers. As it turns out, these numbers ar...

  1. Quantum algebras as quantizations of dual Poisson–Lie groups

    International Nuclear Information System (INIS)

    Ballesteros, Ángel; Musso, Fabio

    2013-01-01

    A systematic computational approach for the explicit construction of any quantum Hopf algebra (U z (g), Δ z ) starting from the Lie bialgebra (g, δ) that gives the first-order deformation of the coproduct map Δ z is presented. The procedure is based on the well-known ‘quantum duality principle’, namely the fact that any quantum algebra can be viewed as the quantization of the unique Poisson–Lie structure (G*, Λ g ) on the dual group G*, which is obtained by exponentiating the Lie algebra g* defined by the dual map δ*. From this perspective, the coproduct for U z (g) is just the pull-back of the group law for G*, and the Poisson analogues of the quantum commutation rules for U z (g) are given by the unique Poisson–Lie structure Λ g on G* whose linearization is the Poisson analogue of the initial Lie algebra g. This approach is shown to be a very useful technical tool in order to solve the Lie bialgebra quantization problem explicitly since, once a Lie bialgebra (g, δ) is given, the full dual Poisson–Lie group (G*, Λ) can be obtained either by applying standard Poisson–Lie group techniques or by implementing the algorithm presented here with the aid of symbolic manipulation programs. As a consequence, the quantization of (G*, Λ) will give rise to the full U z (g) quantum algebra, provided that ordering problems are appropriately fixed through the choice of certain local coordinates on G* whose coproduct fulfils a precise ‘quantum symmetry’ property. The applicability of this approach is explicitly demonstrated by reviewing the construction of several instances of quantum deformations of physically relevant Lie algebras such as sl(2,R), the (2+1) anti-de Sitter algebra so(2, 2) and the Poincaré algebra in (3+1) dimensions. (paper)

  2. Fast Erasure-and error decoding of algebraic geometry codes up to the Feng-Rao bound

    DEFF Research Database (Denmark)

    Høholdt, Tom; Jensen, Helge Elbrønd; Sakata, Shojiro

    1998-01-01

    This correspondence gives an errata (that is erasure-and error-) decoding algorithm of one-point algebraic-geometry codes up to the Feng-Rao designed minimum distance using Sakata's multidimensional generalization of the Berlekamp-Massey algorithm and the voting procedure of Feng and Rao....

  3. Operadic formulation of topological vertex algebras and gerstenhaber or Batalin-Vilkovisky algebras

    International Nuclear Information System (INIS)

    Huang Yizhi

    1994-01-01

    We give the operadic formulation of (weak, strong) topological vertex algebras, which are variants of topological vertex operator algebras studied recently by Lian and Zuckerman. As an application, we obtain a conceptual and geometric construction of the Batalin-Vilkovisky algebraic structure (or the Gerstenhaber algebra structure) on the cohomology of a topological vertex algebra (or of a weak topological vertex algebra) by combining this operadic formulation with a theorem of Getzler (or of Cohen) which formulates Batalin-Vilkovisky algebras (or Gerstenhaber algebras) in terms of the homology of the framed little disk operad (or of the little disk operad). (orig.)

  4. Fast decoding of codes from algebraic plane curves

    DEFF Research Database (Denmark)

    Justesen, Jørn; Larsen, Knud J.; Jensen, Helge Elbrønd

    1992-01-01

    Improvement to an earlier decoding algorithm for codes from algebraic geometry is presented. For codes from an arbitrary regular plane curve the authors correct up to d*/2-m2 /8+m/4-9/8 errors, where d* is the designed distance of the code and m is the degree of the curve. The complexity of finding...

  5. One-particle many-body Green's function theory: Algebraic recursive definitions, linked-diagram theorem, irreducible-diagram theorem, and general-order algorithms.

    Science.gov (United States)

    Hirata, So; Doran, Alexander E; Knowles, Peter J; Ortiz, J V

    2017-07-28

    A thorough analytical and numerical characterization of the whole perturbation series of one-particle many-body Green's function (MBGF) theory is presented in a pedagogical manner. Three distinct but equivalent algebraic (first-quantized) recursive definitions of the perturbation series of the Green's function are derived, which can be combined with the well-known recursion for the self-energy. Six general-order algorithms of MBGF are developed, each implementing one of the three recursions, the ΔMPn method (where n is the perturbation order) [S. Hirata et al., J. Chem. Theory Comput. 11, 1595 (2015)], the automatic generation and interpretation of diagrams, or the numerical differentiation of the exact Green's function with a perturbation-scaled Hamiltonian. They all display the identical, nondivergent perturbation series except ΔMPn, which agrees with MBGF in the diagonal and frequency-independent approximations at 1≤n≤3 but converges at the full-configuration-interaction (FCI) limit at n=∞ (unless it diverges). Numerical data of the perturbation series are presented for Koopmans and non-Koopmans states to quantify the rate of convergence towards the FCI limit and the impact of the diagonal, frequency-independent, or ΔMPn approximation. The diagrammatic linkedness and thus size-consistency of the one-particle Green's function and self-energy are demonstrated at any perturbation order on the basis of the algebraic recursions in an entirely time-independent (frequency-domain) framework. The trimming of external lines in a one-particle Green's function to expose a self-energy diagram and the removal of reducible diagrams are also justified mathematically using the factorization theorem of Frantz and Mills. Equivalence of ΔMPn and MBGF in the diagonal and frequency-independent approximations at 1≤n≤3 is algebraically proven, also ascribing the differences at n = 4 to the so-called semi-reducible and linked-disconnected diagrams.

  6. Seismic noise attenuation using an online subspace tracking algorithm

    NARCIS (Netherlands)

    Zhou, Yatong; Li, Shuhua; Zhang, D.; Chen, Yangkang

    2018-01-01

    We propose a new low-rank based noise attenuation method using an efficient algorithm for tracking subspaces from highly corrupted seismic observations. The subspace tracking algorithm requires only basic linear algebraic manipulations. The algorithm is derived by analysing incremental gradient

  7. A note on probabilistic models over strings: the linear algebra approach.

    Science.gov (United States)

    Bouchard-Côté, Alexandre

    2013-12-01

    Probabilistic models over strings have played a key role in developing methods that take into consideration indels as phylogenetically informative events. There is an extensive literature on using automata and transducers on phylogenies to do inference on these probabilistic models, in which an important theoretical question is the complexity of computing the normalization of a class of string-valued graphical models. This question has been investigated using tools from combinatorics, dynamic programming, and graph theory, and has practical applications in Bayesian phylogenetics. In this work, we revisit this theoretical question from a different point of view, based on linear algebra. The main contribution is a set of results based on this linear algebra view that facilitate the analysis and design of inference algorithms on string-valued graphical models. As an illustration, we use this method to give a new elementary proof of a known result on the complexity of inference on the "TKF91" model, a well-known probabilistic model over strings. Compared to previous work, our proving method is easier to extend to other models, since it relies on a novel weak condition, triangular transducers, which is easy to establish in practice. The linear algebra view provides a concise way of describing transducer algorithms and their compositions, opens the possibility of transferring fast linear algebra libraries (for example, based on GPUs), as well as low rank matrix approximation methods, to string-valued inference problems.

  8. Exact solution of some linear matrix equations using algebraic methods

    Science.gov (United States)

    Djaferis, T. E.; Mitter, S. K.

    1977-01-01

    A study is done of solution methods for Linear Matrix Equations including Lyapunov's equation, using methods of modern algebra. The emphasis is on the use of finite algebraic procedures which are easily implemented on a digital computer and which lead to an explicit solution to the problem. The action f sub BA is introduced a Basic Lemma is proven. The equation PA + BP = -C as well as the Lyapunov equation are analyzed. Algorithms are given for the solution of the Lyapunov and comment is given on its arithmetic complexity. The equation P - A'PA = Q is studied and numerical examples are given.

  9. Wn(2) algebras

    International Nuclear Information System (INIS)

    Feigin, B.L.; Semikhatov, A.M.

    2004-01-01

    We construct W-algebra generalizations of the sl-circumflex(2) algebra-W algebras W n (2) generated by two currents E and F with the highest pole of order n in their OPE. The n=3 term in this series is the Bershadsky-Polyakov W 3 (2) algebra. We define these algebras as a centralizer (commutant) of the Uqs-bar (n vertical bar 1) quantum supergroup and explicitly find the generators in a factored, 'Miura-like' form. Another construction of the W n (2) algebras is in terms of the coset sl-circumflex(n vertical bar 1)/sl-circumflex(n). The relation between the two constructions involves the 'duality' (k+n-1)(k'+n-1)=1 between levels k and k' of two sl-circumflex(n) algebras

  10. Properties of coupled-cluster equations originating in excitation sub-algebras

    Science.gov (United States)

    Kowalski, Karol

    2018-03-01

    In this paper, we discuss properties of single-reference coupled cluster (CC) equations associated with the existence of sub-algebras of excitations that allow one to represent CC equations in a hybrid fashion where the cluster amplitudes associated with these sub-algebras can be obtained by solving the corresponding eigenvalue problem. For closed-shell formulations analyzed in this paper, the hybrid representation of CC equations provides a natural way for extending active-space and seniority number concepts to provide an accurate description of electron correlation effects. Moreover, a new representation can be utilized to re-define iterative algorithms used to solve CC equations, especially for tough cases defined by the presence of strong static and dynamical correlation effects. We will also explore invariance properties associated with excitation sub-algebras to define a new class of CC approximations referred to in this paper as the sub-algebra-flow-based CC methods. We illustrate the performance of these methods on the example of ground- and excited-state calculations for commonly used small benchmark systems.

  11. Monolithic multigrid method for the coupled Stokes flow and deformable porous medium system

    NARCIS (Netherlands)

    P. Luo (Peiyao); C. Rodrigo (Carmen); F.J. Gaspar Lorenz (Franscisco); C.W. Oosterlee (Cornelis)

    2018-01-01

    textabstractThe interaction between fluid flow and a deformable porous medium is a complicated multi-physics problem, which can be described by a coupled model based on the Stokes and poroelastic equations. A monolithic multigrid method together with either a coupled Vanka smoother or a decoupled

  12. Multigrid technique and Optimized Schwarz method on block-structured grids with discontinuous interfaces

    DEFF Research Database (Denmark)

    Kolmogorov, Dmitry; Sørensen, Niels N.; Shen, Wen Zhong

    2013-01-01

    An Optimized Schwarz method using Robin boundary conditions for relaxation scheme is presented in the frame of Multigrid method on discontinuous grids. At each iteration the relaxation scheme is performed in two steps: one step with Dirichlet and another step with Robin boundary conditions at inn...

  13. The vacuum preserving Lie algebra of a classical W-algebra

    International Nuclear Information System (INIS)

    Feher, L.; Tsutsui, I.

    1993-07-01

    We simplify and generalize an argument due to Bowcock and Watts showing that one can associate a finite Lie algebra (the 'classical vacuum preserving algebra') containing the Moebius sl(2) subalgebra to any classical W-algebra. Our construction is based on a kinematical analysis of the Poisson brackets of quasi-fields. In the case of the W S G -subalgebra S of a simple Lie algebra G, we exhibit a natural isomorphism between this finite Lie algebra and G whereby the Moebius sl(2) is identified with S. (orig.)

  14. Nonflexible Lie-admissible algebras

    International Nuclear Information System (INIS)

    Myung, H.C.

    1978-01-01

    We discuss the structure of Lie-admissible algebras which are defined by nonflexible identities. These algebras largely arise from the antiflexible algebras, 2-varieties and associator dependent algebras. The nonflexible Lie-admissible algebras in our discussion are in essence byproducts of the study of nonassociative algebras defined by identities of degree 3. The main purpose is to discuss the classification of simple Lie-admissible algebras of nonflexible type

  15. On 2-Banach algebras

    International Nuclear Information System (INIS)

    Mohammad, N.; Siddiqui, A.H.

    1987-11-01

    The notion of a 2-Banach algebra is introduced and its structure is studied. After a short discussion of some fundamental properties of bivectors and tensor product, several classical results of Banach algebras are extended to the 2-Banach algebra case. A condition under which a 2-Banach algebra becomes a Banach algebra is obtained and the relation between algebra of bivectors and 2-normed algebra is discussed. 11 refs

  16. Algebra

    CERN Document Server

    Flanders, Harley

    1975-01-01

    Algebra presents the essentials of algebra with some applications. The emphasis is on practical skills, problem solving, and computational techniques. Topics covered range from equations and inequalities to functions and graphs, polynomial and rational functions, and exponentials and logarithms. Trigonometric functions and complex numbers are also considered, together with exponentials and logarithms.Comprised of eight chapters, this book begins with a discussion on the fundamentals of algebra, each topic explained, illustrated, and accompanied by an ample set of exercises. The proper use of a

  17. Lukasiewicz-Moisil algebras

    CERN Document Server

    Boicescu, V; Georgescu, G; Rudeanu, S

    1991-01-01

    The Lukasiewicz-Moisil algebras were created by Moisil as an algebraic counterpart for the many-valued logics of Lukasiewicz. The theory of LM-algebras has developed to a considerable extent both as an algebraic theory of intrinsic interest and in view of its applications to logic and switching theory.This book gives an overview of the theory, comprising both classical results and recent contributions, including those of the authors. N-valued and &THgr;-valued algebras are presented, as well as &THgr;-algebras with negation.Mathematicians interested in lattice theory or symbolic logic, and computer scientists, will find in this monograph stimulating material for further research.

  18. Abstract Algebra for Algebra Teaching: Influencing School Mathematics Instruction

    Science.gov (United States)

    Wasserman, Nicholas H.

    2016-01-01

    This article explores the potential for aspects of abstract algebra to be influential for the teaching of school algebra (and early algebra). Using national standards for analysis, four primary areas common in school mathematics--and their progression across elementary, middle, and secondary mathematics--where teaching may be transformed by…

  19. The Boolean algebra and central Galois algebras

    Directory of Open Access Journals (Sweden)

    George Szeto

    2001-01-01

    Full Text Available Let B be a Galois algebra with Galois group G, Jg={b∈B∣bx=g(xb   for all   x∈B} for g∈G, and BJg=Beg for a central idempotent eg. Then a relation is given between the set of elements in the Boolean algebra (Ba,≤ generated by {0,eg∣g∈G} and a set of subgroups of G, and a central Galois algebra Be with a Galois subgroup of G is characterized for an e∈Ba.

  20. Generalization of mixed multiscale finite element methods with applications

    Energy Technology Data Exchange (ETDEWEB)

    Lee, C S [Texas A & M Univ., College Station, TX (United States)

    2016-08-01

    Many science and engineering problems exhibit scale disparity and high contrast. The small scale features cannot be omitted in the physical models because they can affect the macroscopic behavior of the problems. However, resolving all the scales in these problems can be prohibitively expensive. As a consequence, some types of model reduction techniques are required to design efficient solution algorithms. For practical purpose, we are interested in mixed finite element problems as they produce solutions with certain conservative properties. Existing multiscale methods for such problems include the mixed multiscale finite element methods. We show that for complicated problems, the mixed multiscale finite element methods may not be able to produce reliable approximations. This motivates the need of enrichment for coarse spaces. Two enrichment approaches are proposed, one is based on generalized multiscale finte element metthods (GMsFEM), while the other is based on spectral element-based algebraic multigrid (rAMGe). The former one, which is called mixed GMsFEM, is developed for both Darcy’s flow and linear elasticity. Application of the algorithm in two-phase flow simulations are demonstrated. For linear elasticity, the algorithm is subtly modified due to the symmetry requirement of the stress tensor. The latter enrichment approach is based on rAMGe. The algorithm differs from GMsFEM in that both of the velocity and pressure spaces are coarsened. Due the multigrid nature of the algorithm, recursive application is available, which results in an efficient multilevel construction of the coarse spaces. Stability, convergence analysis, and exhaustive numerical experiments are carried out to validate the proposed enrichment approaches. iii

  1. Wavelets and quantum algebras

    International Nuclear Information System (INIS)

    Ludu, A.; Greiner, M.

    1995-09-01

    A non-linear associative algebra is realized in terms of translation and dilation operators, and a wavelet structure generating algebra is obtained. We show that this algebra is a q-deformation of the Fourier series generating algebra, and reduces to this for certain value of the deformation parameter. This algebra is also homeomorphic with the q-deformed su q (2) algebra and some of its extensions. Through this algebraic approach new methods for obtaining the wavelets are introduced. (author). 20 refs

  2. Novikov-Jordan algebras

    OpenAIRE

    Dzhumadil'daev, A. S.

    2002-01-01

    Algebras with identity $(a\\star b)\\star (c\\star d) -(a\\star d)\\star(c\\star b)$ $=(a,b,c)\\star d-(a,d,c)\\star b$ are studied. Novikov algebras under Jordan multiplication and Leibniz dual algebras satisfy this identity. If algebra with such identity has unit, then it is associative and commutative.

  3. Fast algorithms for chiral fermions in 2 dimensions

    Directory of Open Access Journals (Sweden)

    Hyka (Xhako Dafina

    2018-01-01

    Full Text Available In lattice QCD simulations the formulation of the theory in lattice should be chiral in order that symmetry breaking happens dynamically from interactions. In order to guarantee this symmetry on the lattice one uses overlap and domain wall fermions. On the other hand high computational cost of lattice QCD simulations with overlap or domain wall fermions remains a major obstacle of research in the field of elementary particles. We have developed the preconditioned GMRESR algorithm as fast inverting algorithm for chiral fermions in U(1 lattice gauge theory. In this algorithm we used the geometric multigrid idea along the extra dimension.The main result of this work is that the preconditioned GMRESR is capable to accelerate the convergence 2 to 12 times faster than the other optimal algorithms (SHUMR for different coupling constant and lattice 32x32. Also, in this paper we tested it for larger lattice size 64x64. From the results of simulations we can see that our algorithm is faster than SHUMR. This is a very promising result that this algorithm can be adapted also in 4 dimension.

  4. (Quasi-)Poisson enveloping algebras

    OpenAIRE

    Yang, Yan-Hong; Yao, Yuan; Ye, Yu

    2010-01-01

    We introduce the quasi-Poisson enveloping algebra and Poisson enveloping algebra for a non-commutative Poisson algebra. We prove that for a non-commutative Poisson algebra, the category of quasi-Poisson modules is equivalent to the category of left modules over its quasi-Poisson enveloping algebra, and the category of Poisson modules is equivalent to the category of left modules over its Poisson enveloping algebra.

  5. Iterated Leavitt Path Algebras

    International Nuclear Information System (INIS)

    Hazrat, R.

    2009-11-01

    Leavitt path algebras associate to directed graphs a Z-graded algebra and in their simplest form recover the Leavitt algebras L(1,k). In this note, we introduce iterated Leavitt path algebras associated to directed weighted graphs which have natural ± Z grading and in their simplest form recover the Leavitt algebras L(n,k). We also characterize Leavitt path algebras which are strongly graded. (author)

  6. A Fast Algorithm for Generating Permutation Distribution of Ranks in ...

    African Journals Online (AJOL)

    ... function of the distribution of the ranks. This further gives insight into the permutation distribution of a rank statistics. The algorithm is implemented with the aid of the computer algebra system Mathematica. Key words: Combinatorics, generating function, permutation distribution, rank statistics, partitions, computer algebra.

  7. Modular Regularization Algorithms

    DEFF Research Database (Denmark)

    Jacobsen, Michael

    2004-01-01

    The class of linear ill-posed problems is introduced along with a range of standard numerical tools and basic concepts from linear algebra, statistics and optimization. Known algorithms for solving linear inverse ill-posed problems are analyzed to determine how they can be decomposed into indepen...

  8. Multigrid techniques with non-standard coarsening and group relaxation methods

    International Nuclear Information System (INIS)

    Danaee, A.

    1989-06-01

    In the usual (standard) multigrid methods, doubling of grid sizes with different smoothing iterations (pointwise, or blockwise) has been considered by different authors. Some have indicated that a large coarsening can also be used, but is not beneficial (cf. H3, p.59). In this paper, it is shown that with a suitable blockwise smoothing scheme, some advantages could be achieved even with a factor of H l-1 /h l = 3. (author). 10 refs, 2 figs, 6 tabs

  9. A multigrid based 3D space-charge routine in the tracking code GPT

    NARCIS (Netherlands)

    Pöplau, G.; Rienen, van U.; Loos, de M.J.; Geer, van der S.B.; Berz, M.; Makino, K.

    2005-01-01

    Fast calculation of3D non-linear space-charge fields is essential for the simulation ofhigh-brightness charged particle beams. We report on our development of a new 3D spacecharge routine in the General Particle Tracer (GPT) code. The model is based on a nonequidistant multigrid Poisson solver that

  10. Algebraic topological entropy

    International Nuclear Information System (INIS)

    Hudetz, T.

    1989-01-01

    As a 'by-product' of the Connes-Narnhofer-Thirring theory of dynamical entropy for (originally non-Abelian) nuclear C * -algebras, the well-known variational principle for topological entropy is eqivalently reformulated in purly algebraically defined terms for (separable) Abelian C * -algebras. This 'algebraic variational principle' should not only nicely illustrate the 'feed-back' of methods developed for quantum dynamical systems to the classical theory, but it could also be proved directly by 'algebraic' methods and could thus further simplify the original proof of the variational principle (at least 'in principle'). 23 refs. (Author)

  11. Linearizing W-algebras

    International Nuclear Information System (INIS)

    Krivonos, S.O.; Sorin, A.S.

    1994-06-01

    We show that the Zamolodchikov's and Polyakov-Bershadsky nonlinear algebras W 3 and W (2) 3 can be embedded as subalgebras into some linear algebras with finite set of currents. Using these linear algebras we find new field realizations of W (2) 3 and W 3 which could be a starting point for constructing new versions of W-string theories. We also reveal a number of hidden relationships between W 3 and W (2) 3 . We conjecture that similar linear algebras can exist for other W-algebra as well. (author). 10 refs

  12. Algorithms and Methods for High-Performance Model Predictive Control

    DEFF Research Database (Denmark)

    Frison, Gianluca

    routines employed in the numerical tests. The main focus of this thesis is on linear MPC problems. In this thesis, both the algorithms and their implementation are equally important. About the implementation, a novel implementation strategy for the dense linear algebra routines in embedded optimization...... is proposed, aiming at improving the computational performance in case of small matrices. About the algorithms, they are built on top of the proposed linear algebra, and they are tailored to exploit the high-level structure of the MPC problems, with special care on reducing the computational complexity....

  13. Quantum deformed su(mvertical stroke n) algebra and superconformal algebra on quantum superspace

    International Nuclear Information System (INIS)

    Kobayashi, Tatsuo

    1993-01-01

    We study a deformed su(mvertical stroke n) algebra on a quantum superspace. Some interesting aspects of the deformed algebra are shown. As an application of the deformed algebra we construct a deformed superconformal algebra. From the deformed su(1vertical stroke 4) algebra, we derive deformed Lorentz, translation of Minkowski space, iso(2,2) and its supersymmetric algebras as closed subalgebras with consistent automorphisms. (orig.)

  14. Performances of new reconstruction algorithms for CT-TDLAS (computer tomography-tunable diode laser absorption spectroscopy)

    International Nuclear Information System (INIS)

    Jeon, Min-Gyu; Deguchi, Yoshihiro; Kamimoto, Takahiro; Doh, Deog-Hee; Cho, Gyeong-Rae

    2017-01-01

    Highlights: • The measured data were successfully used for generating absorption spectra. • Four different reconstruction algorithms, ART, MART, SART and SMART were evaluated. • The calculation speed of convergence by the SMART algorithm was the fastest. • SMART was the most reliable algorithm for reconstructing the multiple signals. - Abstract: Recent advent of the tunable lasers made to measure simultaneous temperature and concentration fields of the gases. CT-TDLAS (computed tomography-tunable diode laser absorption spectroscopy) is one the leading techniques for the measurements of temperature and concentration fields of the gases. In CT-TDLAS, the accuracies of the measurement results are strongly dependent upon the reconstruction algorithms. In this study, four different reconstruction algorithms have been tested numerically using experimental data sets measured by thermocouples for combustion fields. Three reconstruction algorithms, MART (multiplicative algebraic reconstruction technique) algorithm, SART (simultaneous algebraic reconstruction technique) algorithm and SMART (simultaneous multiplicative algebraic reconstruction technique) algorithm, are newly proposed for CT-TDLAS in this study. The calculation results obtained by the three algorithms have been compared with previous algorithm, ART (algebraic reconstruction technique) algorithm. Phantom data sets have been generated by the use of thermocouples data obtained in an actual experiment. The data of the Harvard HITRAN table in which the thermo-dynamical properties and the light spectrum of the H_2O are listed were used for the numerical test. The reconstructed temperature and concentration fields were compared with the original HITRAN data, through which the constructed methods are validated. The performances of the four reconstruction algorithms were demonstrated. This method is expected to enhance the practicality of CT-TDLAS.

  15. Linear algebraic groups

    CERN Document Server

    Springer, T A

    1998-01-01

    "[The first] ten chapters...are an efficient, accessible, and self-contained introduction to affine algebraic groups over an algebraically closed field. The author includes exercises and the book is certainly usable by graduate students as a text or for self-study...the author [has a] student-friendly style… [The following] seven chapters... would also be a good introduction to rationality issues for algebraic groups. A number of results from the literature…appear for the first time in a text." –Mathematical Reviews (Review of the Second Edition) "This book is a completely new version of the first edition. The aim of the old book was to present the theory of linear algebraic groups over an algebraically closed field. Reading that book, many people entered the research field of linear algebraic groups. The present book has a wider scope. Its aim is to treat the theory of linear algebraic groups over arbitrary fields. Again, the author keeps the treatment of prerequisites self-contained. The material of t...

  16. Extended conformal algebras

    International Nuclear Information System (INIS)

    Goddard, Peter

    1990-01-01

    The algebra of the group of conformal transformations in two dimensions consists of two commuting copies of the Virasoro algebra. In many mathematical and physical contexts, the representations of ν which are relevant satisfy two conditions: they are unitary and they have the ''positive energy'' property that L o is bounded below. In an irreducible unitary representation the central element c takes a fixed real value. In physical contexts, the value of c is a characteristic of a theory. If c < 1, it turns out that the conformal algebra is sufficient to ''solve'' the theory, in the sense of relating the calculation of the infinite set of physically interesting quantities to a finite subset which can be handled in principle. For c ≥ 1, this is no longer the case for the algebra alone and one needs some sort of extended conformal algebra, such as the superconformal algebra. It is these algebras that this paper aims at addressing. (author)

  17. Generalized symmetry algebras

    International Nuclear Information System (INIS)

    Dragon, N.

    1979-01-01

    The possible use of trilinear algebras as symmetry algebras for para-Fermi fields is investigated. The shortcomings of the examples are argued to be a general feature of such generalized algebras. (author)

  18. Algebraic structures in generalized Clifford analysis and applications to boundary value problems

    Directory of Open Access Journals (Sweden)

    José Játem

    2015-12-01

    Full Text Available The present article has a threefold purpose: First it is a survey of the algebraic structures of generalized Clifford-type algebras and shows the main results of the corresponding Clifford-type analysis and its application to boundary value problems known so far. Second it is aimed to implement algorithms to provide the fast and accurate computation of boundary value problems for inhomogeneous equations in the framework of the generalized Clifford analysis. Finally it is also aimed to encourage the development of a generalized discrete Clifford analysis.

  19. Rota-Baxter algebras and the Hopf algebra of renormalization

    Energy Technology Data Exchange (ETDEWEB)

    Ebrahimi-Fard, K.

    2006-06-15

    Recently, the theory of renormalization in perturbative quantum field theory underwent some exciting new developments. Kreimer discovered an organization of Feynman graphs into combinatorial Hopf algebras. The process of renormalization is captured by a factorization theorem for regularized Hopf algebra characters. Hereby the notion of Rota-Baxter algebras enters the scene. In this work we develop in detail several mathematical aspects of Rota-Baxter algebras as they appear also in other sectors closely related to perturbative renormalization, to wit, for instance multiple-zeta-values and matrix differential equations. The Rota-Baxter picture enables us to present the algebraic underpinning for the Connes-Kreimer Birkhoff decomposition in a concise way. This is achieved by establishing a general factorization theorem for filtered algebras. Which in turn follows from a new recursion formula based on the Baker-Campbell-Hausdorff formula. This allows us to generalize a classical result due to Spitzer to non-commutative Rota-Baxter algebras. The Baker-Campbell-Hausdorff based recursion turns out to be a generalization of Magnus' expansion in numerical analysis to generalized integration operators. We will exemplify these general results by establishing a simple representation of the combinatorics of renormalization in terms of triangular matrices. We thereby recover in the presence of a Rota-Baxter operator the matrix representation of the Birkhoff decomposition of Connes and Kreimer. (orig.)

  20. Rota-Baxter algebras and the Hopf algebra of renormalization

    International Nuclear Information System (INIS)

    Ebrahimi-Fard, K.

    2006-06-01

    Recently, the theory of renormalization in perturbative quantum field theory underwent some exciting new developments. Kreimer discovered an organization of Feynman graphs into combinatorial Hopf algebras. The process of renormalization is captured by a factorization theorem for regularized Hopf algebra characters. Hereby the notion of Rota-Baxter algebras enters the scene. In this work we develop in detail several mathematical aspects of Rota-Baxter algebras as they appear also in other sectors closely related to perturbative renormalization, to wit, for instance multiple-zeta-values and matrix differential equations. The Rota-Baxter picture enables us to present the algebraic underpinning for the Connes-Kreimer Birkhoff decomposition in a concise way. This is achieved by establishing a general factorization theorem for filtered algebras. Which in turn follows from a new recursion formula based on the Baker-Campbell-Hausdorff formula. This allows us to generalize a classical result due to Spitzer to non-commutative Rota-Baxter algebras. The Baker-Campbell-Hausdorff based recursion turns out to be a generalization of Magnus' expansion in numerical analysis to generalized integration operators. We will exemplify these general results by establishing a simple representation of the combinatorics of renormalization in terms of triangular matrices. We thereby recover in the presence of a Rota-Baxter operator the matrix representation of the Birkhoff decomposition of Connes and Kreimer. (orig.)

  1. Galilean contractions of W-algebras

    Directory of Open Access Journals (Sweden)

    Jørgen Rasmussen

    2017-09-01

    Full Text Available Infinite-dimensional Galilean conformal algebras can be constructed by contracting pairs of symmetry algebras in conformal field theory, such as W-algebras. Known examples include contractions of pairs of the Virasoro algebra, its N=1 superconformal extension, or the W3 algebra. Here, we introduce a contraction prescription of the corresponding operator-product algebras, or equivalently, a prescription for contracting tensor products of vertex algebras. With this, we work out the Galilean conformal algebras arising from contractions of N=2 and N=4 superconformal algebras as well as of the W-algebras W(2,4, W(2,6, W4, and W5. The latter results provide evidence for the existence of a whole new class of W-algebras which we call Galilean W-algebras. We also apply the contraction prescription to affine Lie algebras and find that the ensuing Galilean affine algebras admit a Sugawara construction. The corresponding central charge is level-independent and given by twice the dimension of the underlying finite-dimensional Lie algebra. Finally, applications of our results to the characterisation of structure constants in W-algebras are proposed.

  2. Quantum affine algebras and deformations of the virasoro and W-algebras

    International Nuclear Information System (INIS)

    Frenkel, E.; Reshetikhin, N.

    1996-01-01

    Using the Wakimoto realization of quantum affine algebras we define new Poisson algebras, which are q-deformations of the classical W-algebras. We also define their free field realizations, i.e. homomorphisms into some Heisenberg-Poisson algebras. The formulas for these homomorphisms coincide with formulas for spectra of transfer-matrices in the corresponding quantum integrable models derived by the Bethe-Ansatz method. (orig.)

  3. Algebraic entropy for algebraic maps

    International Nuclear Information System (INIS)

    Hone, A N W; Ragnisco, Orlando; Zullo, Federico

    2016-01-01

    We propose an extension of the concept of algebraic entropy, as introduced by Bellon and Viallet for rational maps, to algebraic maps (or correspondences) of a certain kind. The corresponding entropy is an index of the complexity of the map. The definition inherits the basic properties from the definition of entropy for rational maps. We give an example with positive entropy, as well as two examples taken from the theory of Bäcklund transformations. (letter)

  4. On hyper BCC-algebras

    OpenAIRE

    Borzooei, R. A.; Dudek, W. A.; Koohestani, N.

    2006-01-01

    We study hyper BCC-algebras which are a common generalization of BCC-algebras and hyper BCK-algebras. In particular, we investigate different types of hyper BCC-ideals and describe the relationship among them. Next, we calculate all nonisomorphic 22 hyper BCC-algebras of order 3 of which only three are not hyper BCK-algebras.

  5. On hyper BCC-algebras

    Directory of Open Access Journals (Sweden)

    R. A. Borzooei

    2006-01-01

    Full Text Available We study hyper BCC-algebras which are a common generalization of BCC-algebras and hyper BCK-algebras. In particular, we investigate different types of hyper BCC-ideals and describe the relationship among them. Next, we calculate all nonisomorphic 22 hyper BCC-algebras of order 3 of which only three are not hyper BCK-algebras.

  6. Algebraic theory of numbers

    CERN Document Server

    Samuel, Pierre

    2008-01-01

    Algebraic number theory introduces students not only to new algebraic notions but also to related concepts: groups, rings, fields, ideals, quotient rings and quotient fields, homomorphisms and isomorphisms, modules, and vector spaces. Author Pierre Samuel notes that students benefit from their studies of algebraic number theory by encountering many concepts fundamental to other branches of mathematics - algebraic geometry, in particular.This book assumes a knowledge of basic algebra but supplements its teachings with brief, clear explanations of integrality, algebraic extensions of fields, Gal

  7. Adaptive parallel multigrid for Euler and incompressible Navier-Stokes equations

    Energy Technology Data Exchange (ETDEWEB)

    Trottenberg, U.; Oosterlee, K.; Ritzdorf, H. [and others

    1996-12-31

    The combination of (1) very efficient solution methods (Multigrid), (2) adaptivity, and (3) parallelism (distributed memory) clearly is absolutely necessary for future oriented numerics but still regarded as extremely difficult or even unsolved. We show that very nice results can be obtained for real life problems. Our approach is straightforward (based on {open_quotes}MLAT{close_quotes}). But, of course, reasonable refinement and load-balancing strategies have to be used. Our examples are 2D, but 3D is on the way.

  8. Cryptographic protocol security analysis based on bounded constructing algorithm

    Institute of Scientific and Technical Information of China (English)

    2006-01-01

    An efficient approach to analyzing cryptographic protocols is to develop automatic analysis tools based on formal methods. However, the approach has encountered the high computational complexity problem due to reasons that participants of protocols are arbitrary, their message structures are complex and their executions are concurrent. We propose an efficient automatic verifying algorithm for analyzing cryptographic protocols based on the Cryptographic Protocol Algebra (CPA) model proposed recently, in which algebraic techniques are used to simplify the description of cryptographic protocols and their executions. Redundant states generated in the analysis processes are much reduced by introducing a new algebraic technique called Universal Polynomial Equation and the algorithm can be used to verify the correctness of protocols in the infinite states space. We have implemented an efficient automatic analysis tool for cryptographic protocols, called ACT-SPA, based on this algorithm, and used the tool to check more than 20 cryptographic protocols. The analysis results show that this tool is more efficient, and an attack instance not offered previously is checked by using this tool.

  9. The BRS algebra of a free differential algebra

    International Nuclear Information System (INIS)

    Boukraa, S.

    1987-04-01

    We construct in this work, the Weil and the universal BRS algebras of theories that can have as a gauge symmetry a free differential (Sullivan) algebra, the natural extension of Lie algebras allowing the definition of p-form gauge potentials (p>1). The finite gauge transformations of these potentials are deduced from the infinitesimal ones and the group structure is shown. The geometrical meaning of these p-form gauge potentials is given by the notion of a Quillen superconnection. (author). 19 refs

  10. Pseudo-Riemannian Novikov algebras

    Energy Technology Data Exchange (ETDEWEB)

    Chen Zhiqi; Zhu Fuhai [School of Mathematical Sciences and LPMC, Nankai University, Tianjin 300071 (China)], E-mail: chenzhiqi@nankai.edu.cn, E-mail: zhufuhai@nankai.edu.cn

    2008-08-08

    Novikov algebras were introduced in connection with the Poisson brackets of hydrodynamic-type and Hamiltonian operators in formal variational calculus. Pseudo-Riemannian Novikov algebras denote Novikov algebras with non-degenerate invariant symmetric bilinear forms. In this paper, we find that there is a remarkable geometry on pseudo-Riemannian Novikov algebras, and give a special class of pseudo-Riemannian Novikov algebras.

  11. On the PR-algebras

    International Nuclear Information System (INIS)

    Lebedenko, V.M.

    1978-01-01

    The PR-algebras, i.e. the Lie algebras with commutation relations of [Hsub(i),Hsub(j)]=rsub(ij)Hsub(i)(i< j) type are investigated. On the basis of former results a criterion for the membership of 2-solvable Lie algebras to the PR-algebra class is given. The conditions imposed by the criterion are formulated in the linear algebra language

  12. Introduction to W-algebras

    International Nuclear Information System (INIS)

    Takao, Masaru

    1989-01-01

    We review W-algebras which are generated by stress tensor and primary fields. Associativity plays an important role in determining the extended algebra and further implies the algebras to exist for special values of central charges. Explicitly constructing the algebras including primary fields of spin less than 4, we investigate the closure structure of the Jacobi identity of the extended algebras. (author)

  13. Computational Fluid Dynamics (CFD) Simulations of a Finned Projectile with Microflaps for Flow Control

    Science.gov (United States)

    2016-04-01

    multigrid approach as the means to efficiently solve the linear algebra problem that results in applying an implicit scheme to both steady-state and...projectile, CFD applications , microflaps, optimized control force 16. SECURITY CLASSIFICATION OF: 17. LIMITATION OF ABSTRACT UU 18...counterparts, and successive relaxation allows update of cells as information becomes available and thus aids convergence. CFD++ uses an algebraic

  14. Boolean Operations with Prism Algebraic Patches

    Science.gov (United States)

    Bajaj, Chandrajit; Paoluzzi, Alberto; Portuesi, Simone; Lei, Na; Zhao, Wenqi

    2009-01-01

    In this paper we discuss a symbolic-numeric algorithm for Boolean operations, closed in the algebra of curved polyhedra whose boundary is triangulated with algebraic patches (A-patches). This approach uses a linear polyhedron as a first approximation of both the arguments and the result. On each triangle of a boundary representation of such linear approximation, a piecewise cubic algebraic interpolant is built, using a C1-continuous prism algebraic patch (prism A-patch) that interpolates the three triangle vertices, with given normal vectors. The boundary representation only stores the vertices of the initial triangulation and their external vertex normals. In order to represent also flat and/or sharp local features, the corresponding normal-per-face and/or normal-per-edge may be also given, respectively. The topology is described by storing, for each curved triangle, the two triples of pointers to incident vertices and to adjacent triangles. For each triangle, a scaffolding prism is built, produced by its extreme vertices and normals, which provides a containment volume for the curved interpolating A-patch. When looking for the result of a regularized Boolean operation, the 0-set of a tri-variate polynomial within each such prism is generated, and intersected with the analogous 0-sets of the other curved polyhedron, when two prisms have non-empty intersection. The intersection curves of the boundaries are traced and used to decompose each boundary into the 3 standard classes of subpatches, denoted in, out and on. While tracing the intersection curves, the locally refined triangulation of intersecting patches is produced, and added to the boundary representation. PMID:21516262

  15. (Modular Effect Algebras are Equivalent to (Frobenius Antispecial Algebras

    Directory of Open Access Journals (Sweden)

    Dusko Pavlovic

    2017-01-01

    Full Text Available Effect algebras are one of the generalizations of Boolean algebras proposed in the quest for a quantum logic. Frobenius algebras are a tool of categorical quantum mechanics, used to present various families of observables in abstract, often nonstandard frameworks. Both effect algebras and Frobenius algebras capture their respective fragments of quantum mechanics by elegant and succinct axioms; and both come with their conceptual mysteries. A particularly elegant and mysterious constraint, imposed on Frobenius algebras to characterize a class of tripartite entangled states, is the antispecial law. A particularly contentious issue on the quantum logic side is the modularity law, proposed by von Neumann to mitigate the failure of distributivity of quantum logical connectives. We show that, if quantum logic and categorical quantum mechanics are formalized in the same framework, then the antispecial law of categorical quantum mechanics corresponds to the natural requirement of effect algebras that the units are each other's unique complements; and that the modularity law corresponds to the Frobenius condition. These correspondences lead to the equivalence announced in the title. Aligning the two formalisms, at the very least, sheds new light on the concepts that are more clearly displayed on one side than on the other (such as e.g. the orthogonality. Beyond that, it may also open up new approaches to deep and important problems of quantum mechanics (such as the classification of complementary observables.

  16. Matrix preconditioning: a robust operation for optical linear algebra processors.

    Science.gov (United States)

    Ghosh, A; Paparao, P

    1987-07-15

    Analog electrooptical processors are best suited for applications demanding high computational throughput with tolerance for inaccuracies. Matrix preconditioning is one such application. Matrix preconditioning is a preprocessing step for reducing the condition number of a matrix and is used extensively with gradient algorithms for increasing the rate of convergence and improving the accuracy of the solution. In this paper, we describe a simple parallel algorithm for matrix preconditioning, which can be implemented efficiently on a pipelined optical linear algebra processor. From the results of our numerical experiments we show that the efficacy of the preconditioning algorithm is affected very little by the errors of the optical system.

  17. Compact quantum group C*-algebras as Hopf algebras with approximate unit

    International Nuclear Information System (INIS)

    Do Ngoc Diep; Phung Ho Hai; Kuku, A.O.

    1999-04-01

    In this paper, we construct and study the representation theory of a Hopf C*-algebra with approximate unit, which constitutes quantum analogue of a compact group C*-algebra. The construction is done by first introducing a convolution-product on an arbitrary Hopf algebra H with integral, and then constructing the L 2 and C*-envelopes of H (with the new convolution-product) when H is a compact Hopf *-algebra. (author)

  18. Intervals in Generalized Effect Algebras and their Sub-generalized Effect Algebras

    Directory of Open Access Journals (Sweden)

    Zdenka Riečanová

    2013-01-01

    Full Text Available We consider subsets G of a generalized effect algebra E with 0∈G and such that every interval [0, q]G = [0, q]E ∩ G of G (q ∈ G , q ≠ 0 is a sub-effect algebra of the effect algebra [0, q]E. We give a condition on E and G under which every such G is a sub-generalized effect algebra of E.

  19. Variants of bosonization in parabosonic algebra: the Hopf and super-Hopf structures in parabosonic algebra

    International Nuclear Information System (INIS)

    Kanakoglou, K; Daskaloyannis, C

    2008-01-01

    Parabosonic algebra in finite or infinite degrees of freedom is considered as a Z 2 -graded associative algebra, and is shown to be a Z 2 -graded (or super) Hopf algebra. The super-Hopf algebraic structure of the parabosonic algebra is established directly without appealing to its relation to the osp(1/2n) Lie superalgebraic structure. The notion of super-Hopf algebra is equivalently described as a Hopf algebra in the braided monoidal category CZ 2 M. The bosonization technique for switching a Hopf algebra in the braided monoidal category H M (where H is a quasitriangular Hopf algebra) into an ordinary Hopf algebra is reviewed. In this paper, we prove that for the parabosonic algebra P B , beyond the application of the bosonization technique to the original super-Hopf algebra, a bosonization-like construction is also achieved using two operators, related to the parabosonic total number operator. Both techniques switch the same super-Hopf algebra P B to an ordinary Hopf algebra, thus producing two different variants of P B , with an ordinary Hopf structure

  20. The C*-algebra of a vector bundle and fields of Cuntz algebras

    OpenAIRE

    Vasselli, Ezio

    2004-01-01

    We study the Pimsner algebra associated with the module of continuous sections of a Hilbert bundle, and prove that it is a continuous bundle of Cuntz algebras. We discuss the role of such Pimsner algebras w.r.t. the notion of inner endomorphism. Furthermore, we study bundles of Cuntz algebras carrying a global circle action, and assign to them a class in the representable KK-group of the zero-grade bundle. We compute such class for the Pimsner algebra of a vector bundle.

  1. Bicovariant quantum algebras and quantum Lie algebras

    International Nuclear Information System (INIS)

    Schupp, P.; Watts, P.; Zumino, B.

    1993-01-01

    A bicovariant calculus of differential operators on a quantum group is constructed in a natural way, using invariant maps from Fun(G q ) to U q g, given by elements of the pure braid group. These operators - the 'reflection matrix' Y= triple bond L + SL - being a special case - generate algebras that linearly close under adjoint actions, i.e. they form generalized Lie algebras. We establish the connection between the Hopf algebra formulation of the calculus and a formulation in compact matrix form which is quite powerful for actual computations and as applications we find the quantum determinant and an orthogonality relation for Y in SO q (N). (orig.)

  2. Simple relation algebras

    CERN Document Server

    Givant, Steven

    2017-01-01

    This monograph details several different methods for constructing simple relation algebras, many of which are new with this book. By drawing these seemingly different methods together, all are shown to be aspects of one general approach, for which several applications are given. These tools for constructing and analyzing relation algebras are of particular interest to mathematicians working in logic, algebraic logic, or universal algebra, but will also appeal to philosophers and theoretical computer scientists working in fields that use mathematics. The book is written with a broad audience in mind and features a careful, pedagogical approach; an appendix contains the requisite background material in relation algebras. Over 400 exercises provide ample opportunities to engage with the material, making this a monograph equally appropriate for use in a special topics course or for independent study. Readers interested in pursuing an extended background study of relation algebras will find a comprehensive treatme...

  3. 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.

  4. Optimal Route Searching with Multiple Dynamical Constraints—A Geometric Algebra Approach

    Directory of Open Access Journals (Sweden)

    Dongshuang Li

    2018-05-01

    Full Text Available The process of searching for a dynamic constrained optimal path has received increasing attention in traffic planning, evacuation, and personalized or collaborative traffic service. As most existing multiple constrained optimal path (MCOP methods cannot search for a path given various types of constraints that dynamically change during the search, few approaches for dynamic multiple constrained optimal path (DMCOP with type II dynamics are available for practical use. In this study, we develop a method to solve the DMCOP problem with type II dynamics based on the unification of various types of constraints under a geometric algebra (GA framework. In our method, the network topology and three different types of constraints are represented by using algebraic base coding. With a parameterized optimization of the MCOP algorithm based on a greedy search strategy under the generation-refinement paradigm, this algorithm is found to accurately support the discovery of optimal paths as the constraints of numerical values, nodes, and route structure types are dynamically added to the network. The algorithm was tested with simulated cases of optimal tourism route searches in China’s road networks with various combinations of constraints. The case study indicates that our algorithm can not only solve the DMCOP with different types of constraints but also use constraints to speed up the route filtering.

  5. Boolean algebra

    CERN Document Server

    Goodstein, R L

    2007-01-01

    This elementary treatment by a distinguished mathematician employs Boolean algebra as a simple medium for introducing important concepts of modern algebra. Numerous examples appear throughout the text, plus full solutions.

  6. Combinatorial commutative algebra

    CERN Document Server

    Miller, Ezra

    2005-01-01

    Offers an introduction to combinatorial commutative algebra, focusing on combinatorial techniques for multigraded polynomial rings, semigroup algebras, and determined rings. The chapters in this work cover topics ranging from homological invariants of monomial ideals and their polyhedral resolutions, to tools for studying algebraic varieties.

  7. Topological أ-algebras with Cأ-enveloping algebras II

    Indian Academy of Sciences (India)

    necessarily complete) pro-Cأ-topology which coincides with the relative uniform .... problems in Cأ-algebras, Phillips introduced more general weakly Cأ- .... Banach أ-algebra obtained by completing A=Np in the norm jjxpjjp ¼ pًxق where.

  8. C*-algebras by example

    CERN Document Server

    Davidson, Kenneth R

    1996-01-01

    The subject of C*-algebras received a dramatic revitalization in the 1970s by the introduction of topological methods through the work of Brown, Douglas, and Fillmore on extensions of C*-algebras and Elliott's use of K-theory to provide a useful classification of AF algebras. These results were the beginning of a marvelous new set of tools for analyzing concrete C*-algebras. This book is an introductory graduate level text which presents the basics of the subject through a detailed analysis of several important classes of C*-algebras. The development of operator algebras in the last twenty yea

  9. Angular Multigrid Preconditioner for Krylov-Based Solution Techniques Applied to the Sn Equations with Highly Forward-Peaked Scattering

    Science.gov (United States)

    Turcksin, Bruno; Ragusa, Jean C.; Morel, Jim E.

    2012-01-01

    It is well known that the diffusion synthetic acceleration (DSA) methods for the Sn equations become ineffective in the Fokker-Planck forward-peaked scattering limit. In response to this deficiency, Morel and Manteuffel (1991) developed an angular multigrid method for the 1-D Sn equations. This method is very effective, costing roughly twice as much as DSA per source iteration, and yielding a maximum spectral radius of approximately 0.6 in the Fokker-Planck limit. Pautz, Adams, and Morel (PAM) (1999) later generalized the angular multigrid to 2-D, but it was found that the method was unstable with sufficiently forward-peaked mappings between the angular grids. The method was stabilized via a filtering technique based on diffusion operators, but this filtering also degraded the effectiveness of the overall scheme. The spectral radius was not bounded away from unity in the Fokker-Planck limit, although the method remained more effective than DSA. The purpose of this article is to recast the multidimensional PAM angular multigrid method without the filtering as an Sn preconditioner and use it in conjunction with the Generalized Minimal RESidual (GMRES) Krylov method. The approach ensures stability and our computational results demonstrate that it is also significantly more efficient than an analogous DSA-preconditioned Krylov method.

  10. On the Parallel Elliptic Single/Multigrid Solutions about Aligned and Nonaligned Bodies Using the Virtual Machine for Multiprocessors

    Directory of Open Access Journals (Sweden)

    A. Averbuch

    1994-01-01

    Full Text Available Parallel elliptic single/multigrid solutions around an aligned and nonaligned body are presented and implemented on two multi-user and single-user shared memory multiprocessors (Sequent Symmetry and MOS and on a distributed memory multiprocessor (a Transputer network. Our parallel implementation uses the Virtual Machine for Muli-Processors (VMMP, a software package that provides a coherent set of services for explicitly parallel application programs running on diverse multiple instruction multiple data (MIMD multiprocessors, both shared memory and message passing. VMMP is intended to simplify parallel program writing and to promote portable and efficient programming. Furthermore, it ensures high portability of application programs by implementing the same services on all target multiprocessors. The performance of our algorithm is investigated in detail. It is seen to fit well the above architectures when the number of processors is less than the maximal number of grid points along the axes. In general, the efficiency in the nonaligned case is higher than in the aligned case. Alignment overhead is observed to be up to 200% in the shared-memory case and up to 65% in the message-passing case. We have demonstrated that when using VMMP, the portability of the algorithms is straightforward and efficient.

  11. Algebraic conformal field theory

    International Nuclear Information System (INIS)

    Fuchs, J.; Nationaal Inst. voor Kernfysica en Hoge-Energiefysica

    1991-11-01

    Many conformal field theory features are special versions of structures which are present in arbitrary 2-dimensional quantum field theories. So it makes sense to describe 2-dimensional conformal field theories in context of algebraic theory of superselection sectors. While most of the results of the algebraic theory are rather abstract, conformal field theories offer the possibility to work out many formulae explicitly. In particular, one can construct the full algebra A-bar of global observables and the endomorphisms of A-bar which represent the superselection sectors. Some explicit results are presented for the level 1 so(N) WZW theories; the algebra A-bar is found to be the enveloping algebra of a Lie algebra L-bar which is an extension of the chiral symmetry algebra of the WZW theory. (author). 21 refs., 6 figs

  12. Algorithmic phase diagrams

    Science.gov (United States)

    Hockney, Roger

    1987-01-01

    Algorithmic phase diagrams are a neat and compact representation of the results of comparing the execution time of several algorithms for the solution of the same problem. As an example, the recent results are shown of Gannon and Van Rosendale on the solution of multiple tridiagonal systems of equations in the form of such diagrams. The act of preparing these diagrams has revealed an unexpectedly complex relationship between the best algorithm and the number and size of the tridiagonal systems, which was not evident from the algebraic formulae in the original paper. Even so, for a particular computer, one diagram suffices to predict the best algorithm for all problems that are likely to be encountered the prediction being read directly from the diagram without complex calculation.

  13. Advanced topics in linear algebra weaving matrix problems through the Weyr form

    CERN Document Server

    O'Meara, Kevin; Vinsonhaler, Charles

    2011-01-01

    The Weyr matrix canonical form is a largely unknown cousin of the Jordan canonical form. Discovered by Eduard Weyr in 1885, the Weyr form outperforms the Jordan form in a number of mathematical situations, yet it remains somewhat of a mystery, even to many who are skilled in linear algebra. Written in an engaging style, this book presents various advanced topics in linear algebra linked through the Weyr form. Kevin O'Meara, John Clark, and Charles Vinsonhaler develop the Weyr form from scratch and include an algorithm for computing it. A fascinating duality exists between the Weyr form and the

  14. Vector Network Coding Algorithms

    OpenAIRE

    Ebrahimi, Javad; Fragouli, Christina

    2010-01-01

    We develop new algebraic algorithms for scalar and vector network coding. In vector network coding, the source multicasts information by transmitting vectors of length L, while intermediate nodes process and combine their incoming packets by multiplying them with L x L coding matrices that play a similar role as coding c in scalar coding. Our algorithms for scalar network jointly optimize the employed field size while selecting the coding coefficients. Similarly, for vector coding, our algori...

  15. Boolean algebra essentials

    CERN Document Server

    Solomon, Alan D

    2012-01-01

    REA's Essentials provide quick and easy access to critical information in a variety of different fields, ranging from the most basic to the most advanced. As its name implies, these concise, comprehensive study guides summarize the essentials of the field covered. Essentials are helpful when preparing for exams, doing homework and will remain a lasting reference source for students, teachers, and professionals. Boolean Algebra includes set theory, sentential calculus, fundamental ideas of Boolean algebras, lattices, rings and Boolean algebras, the structure of a Boolean algebra, and Boolean

  16. q-deformed Poincare algebra

    International Nuclear Information System (INIS)

    Ogievetsky, O.; Schmidke, W.B.; Wess, J.; Muenchen Univ.; Zumino, B.; Lawrence Berkeley Lab., CA

    1992-01-01

    The q-differential calculus for the q-Minkowski space is developed. The algebra of the q-derivatives with the q-Lorentz generators is found giving the q-deformation of the Poincare algebra. The reality structure of the q-Poincare algebra is given. The reality structure of the q-differentials is also found. The real Laplaacian is constructed. Finally the comultiplication, counit and antipode for the q-Poincare algebra are obtained making it a Hopf algebra. (orig.)

  17. Generalizing the bms3 and 2D-conformal algebras by expanding the Virasoro algebra

    Science.gov (United States)

    Caroca, Ricardo; Concha, Patrick; Rodríguez, Evelyn; Salgado-Rebolledo, Patricio

    2018-03-01

    By means of the Lie algebra expansion method, the centrally extended conformal algebra in two dimensions and the bms3 algebra are obtained from the Virasoro algebra. We extend this result to construct new families of expanded Virasoro algebras that turn out to be infinite-dimensional lifts of the so-called Bk, Ck and Dk algebras recently introduced in the literature in the context of (super)gravity. We also show how some of these new infinite-dimensional symmetries can be obtained from expanded Kač-Moody algebras using modified Sugawara constructions. Applications in the context of three-dimensional gravity are briefly discussed.

  18. Introduction to quantum algebras

    International Nuclear Information System (INIS)

    Kibler, M.R.

    1992-09-01

    The concept of a quantum algebra is made easy through the investigation of the prototype algebras u qp (2), su q (2) and u qp (1,1). The latter quantum algebras are introduced as deformations of the corresponding Lie algebras; this is achieved in a simple way by means of qp-bosons. The Hopf algebraic structure of u qp (2) is also discussed. The basic ingredients for the representation theory of u qp (2) are given. Finally, in connection with the quantum algebra u qp (2), the qp-analogues of the harmonic oscillator are discussed and of the (spherical and hyperbolical) angular momenta. (author) 50 refs

  19. Fixed points of IA-endomorphisms of a free metabelian Lie algebra

    Indian Academy of Sciences (India)

    Let be a free metabelian Lie algebra of finite rank at least 2. We show the existence of non-trivial fixed points of an -endomorphism of and give an algorithm detecting them. In particular, we prove that the fixed point subalgebra Fix of an -endomorphism of is not finitely generated.

  20. Continuum analogues of contragredient Lie algebras

    International Nuclear Information System (INIS)

    Saveliev, M.V.; Vershik, A.M.

    1989-03-01

    We present an axiomatic formulation of a new class of infinite-dimensional Lie algebras - the generalizations of Z-graded Lie algebras with, generally speaking, an infinite-dimensional Cartan subalgebra and a contiguous set of roots. We call such algebras ''continuum Lie algebras''. The simple Lie algebras of constant growth are encapsulated in our formulation. We pay particular attention to the case when the local algebra is parametrized by a commutative algebra while the Cartan operator (the generalization of the Cartan matrix) is a linear operator. Special examples of these algebras are the Kac-Moody algebras, algebras of Poisson brackets, algebras of vector fields on a manifold, current algebras, and algebras with differential or integro-differential Cartan operator. The nonlinear dynamical systems associated with the continuum contragredient Lie algebras are also considered. (author). 9 refs

  1. Diablo 2.0: A modern DNS/LES code for the incompressible NSE leveraging new time-stepping and multigrid algorithms

    Science.gov (United States)

    Cavaglieri, Daniele; Bewley, Thomas; Mashayek, Ali

    2015-11-01

    We present a new code, Diablo 2.0, for the simulation of the incompressible NSE in channel and duct flows with strong grid stretching near walls. The code leverages the fractional step approach with a few twists. New low-storage IMEX (implicit-explicit) Runge-Kutta time-marching schemes are tested which are superior to the traditional and widely-used CN/RKW3 (Crank-Nicolson/Runge-Kutta-Wray) approach; the new schemes tested are L-stable in their implicit component, and offer improved overall order of accuracy and stability with, remarkably, similar computational cost and storage requirements. For duct flow simulations, our new code also introduces a new smoother for the multigrid solver for the pressure Poisson equation. The classic approach, involving alternating-direction zebra relaxation, is replaced by a new scheme, dubbed tweed relaxation, which achieves the same convergence rate with roughly half the computational cost. The code is then tested on the simulation of a shear flow instability in a duct, a classic problem in fluid mechanics which has been the object of extensive numerical modelling for its role as a canonical pathway to energetic turbulence in several fields of science and engineering.

  2. Lectures on algebraic statistics

    CERN Document Server

    Drton, Mathias; Sullivant, Seth

    2009-01-01

    How does an algebraic geometer studying secant varieties further the understanding of hypothesis tests in statistics? Why would a statistician working on factor analysis raise open problems about determinantal varieties? Connections of this type are at the heart of the new field of "algebraic statistics". In this field, mathematicians and statisticians come together to solve statistical inference problems using concepts from algebraic geometry as well as related computational and combinatorial techniques. The goal of these lectures is to introduce newcomers from the different camps to algebraic statistics. The introduction will be centered around the following three observations: many important statistical models correspond to algebraic or semi-algebraic sets of parameters; the geometry of these parameter spaces determines the behaviour of widely used statistical inference procedures; computational algebraic geometry can be used to study parameter spaces and other features of statistical models.

  3. Quiver W-algebras

    Science.gov (United States)

    Kimura, Taro; Pestun, Vasily

    2018-06-01

    For a quiver with weighted arrows, we define gauge-theory K-theoretic W-algebra generalizing the definition of Shiraishi et al. and Frenkel and Reshetikhin. In particular, we show that the qq-character construction of gauge theory presented by Nekrasov is isomorphic to the definition of the W-algebra in the operator formalism as a commutant of screening charges in the free field representation. Besides, we allow arbitrary quiver and expect interesting applications to representation theory of generalized Borcherds-Kac-Moody Lie algebras, their quantum affinizations and associated W-algebras.

  4. Abstract algebra

    CERN Document Server

    Garrett, Paul B

    2007-01-01

    Designed for an advanced undergraduate- or graduate-level course, Abstract Algebra provides an example-oriented, less heavily symbolic approach to abstract algebra. The text emphasizes specifics such as basic number theory, polynomials, finite fields, as well as linear and multilinear algebra. This classroom-tested, how-to manual takes a more narrative approach than the stiff formalism of many other textbooks, presenting coherent storylines to convey crucial ideas in a student-friendly, accessible manner. An unusual feature of the text is the systematic characterization of objects by universal

  5. College algebra

    CERN Document Server

    Kolman, Bernard

    1985-01-01

    College Algebra, Second Edition is a comprehensive presentation of the fundamental concepts and techniques of algebra. The book incorporates some improvements from the previous edition to provide a better learning experience. It provides sufficient materials for use in the study of college algebra. It contains chapters that are devoted to various mathematical concepts, such as the real number system, the theory of polynomial equations, exponential and logarithmic functions, and the geometric definition of each conic section. Progress checks, warnings, and features are inserted. Every chapter c

  6. Twisted classical Poincare algebras

    International Nuclear Information System (INIS)

    Lukierski, J.; Ruegg, H.; Tolstoy, V.N.; Nowicki, A.

    1993-11-01

    We consider the twisting of Hopf structure for classical enveloping algebra U(g), where g is the inhomogeneous rotations algebra, with explicite formulae given for D=4 Poincare algebra (g=P 4 ). The comultiplications of twisted U F (P 4 ) are obtained by conjugating primitive classical coproducts by F element of U(c)xU(c), where c denotes any Abelian subalgebra of P 4 , and the universal R-matrices for U F (P 4 ) are triangular. As an example we show that the quantum deformation of Poincare algebra recently proposed by Chaichian and Demiczev is a twisted classical Poincare algebra. The interpretation of twisted Poincare algebra as describing relativistic symmetries with clustered 2-particle states is proposed. (orig.)

  7. Adaptive tree multigrids and simplified spherical harmonics approximation in deterministic neutral and charged particle transport

    International Nuclear Information System (INIS)

    Kotiluoto, P.

    2007-05-01

    A new deterministic three-dimensional neutral and charged particle transport code, MultiTrans, has been developed. In the novel approach, the adaptive tree multigrid technique is used in conjunction with simplified spherical harmonics approximation of the Boltzmann transport equation. The development of the new radiation transport code started in the framework of the Finnish boron neutron capture therapy (BNCT) project. Since the application of the MultiTrans code to BNCT dose planning problems, the testing and development of the MultiTrans code has continued in conventional radiotherapy and reactor physics applications. In this thesis, an overview of different numerical radiation transport methods is first given. Special features of the simplified spherical harmonics method and the adaptive tree multigrid technique are then reviewed. The usefulness of the new MultiTrans code has been indicated by verifying and validating the code performance for different types of neutral and charged particle transport problems, reported in separate publications. (orig.)

  8. Pre-Algebra Essentials For Dummies

    CERN Document Server

    Zegarelli, Mark

    2010-01-01

    Many students worry about starting algebra. Pre-Algebra Essentials For Dummies provides an overview of critical pre-algebra concepts to help new algebra students (and their parents) take the next step without fear. Free of ramp-up material, Pre-Algebra Essentials For Dummies contains content focused on key topics only. It provides discrete explanations of critical concepts taught in a typical pre-algebra course, from fractions, decimals, and percents to scientific notation and simple variable equations. This guide is also a perfect reference for parents who need to review critical pre-algebra

  9. An algebraic sub-structuring method for large-scale eigenvalue calculation

    International Nuclear Information System (INIS)

    Yang, C.; Gao, W.; Bai, Z.; Li, X.; Lee, L.; Husbands, P.; Ng, E.

    2004-01-01

    We examine sub-structuring methods for solving large-scale generalized eigenvalue problems from a purely algebraic point of view. We use the term 'algebraic sub-structuring' to refer to the process of applying matrix reordering and partitioning algorithms to divide a large sparse matrix into smaller submatrices from which a subset of spectral components are extracted and combined to provide approximate solutions to the original problem. We are interested in the question of which spectral components one should extract from each sub-structure in order to produce an approximate solution to the original problem with a desired level of accuracy. Error estimate for the approximation to the smallest eigenpair is developed. The estimate leads to a simple heuristic for choosing spectral components (modes) from each sub-structure. The effectiveness of such a heuristic is demonstrated with numerical examples. We show that algebraic sub-structuring can be effectively used to solve a generalized eigenvalue problem arising from the simulation of an accelerator structure. One interesting characteristic of this application is that the stiffness matrix produced by a hierarchical vector finite elements scheme contains a null space of large dimension. We present an efficient scheme to deflate this null space in the algebraic sub-structuring process

  10. An Efficient Algorithm for the Maximum Distance Problem

    Directory of Open Access Journals (Sweden)

    Gabrielle Assunta Grün

    2001-12-01

    Full Text Available Efficient algorithms for temporal reasoning are essential in knowledge-based systems. This is central in many areas of Artificial Intelligence including scheduling, planning, plan recognition, and natural language understanding. As such, scalability is a crucial consideration in temporal reasoning. While reasoning in the interval algebra is NP-complete, reasoning in the less expressive point algebra is tractable. In this paper, we explore an extension to the work of Gerevini and Schubert which is based on the point algebra. In their seminal framework, temporal relations are expressed as a directed acyclic graph partitioned into chains and supported by a metagraph data structure, where time points or events are represented by vertices, and directed edges are labelled with < or ≤. They are interested in fast algorithms for determining the strongest relation between two events. They begin by developing fast algorithms for the case where all points lie on a chain. In this paper, we are interested in a generalization of this, namely we consider the problem of finding the maximum ``distance'' between two vertices in a chain ; this problem arises in real world applications such as in process control and crew scheduling. We describe an O(n time preprocessing algorithm for the maximum distance problem on chains. It allows queries for the maximum number of < edges between two vertices to be answered in O(1 time. This matches the performance of the algorithm of Gerevini and Schubert for determining the strongest relation holding between two vertices in a chain.

  11. Representations of quantum bicrossproduct algebras

    International Nuclear Information System (INIS)

    Arratia, Oscar; Olmo, Mariano A del

    2002-01-01

    We present a method to construct induced representations of quantum algebras which have a bicrossproduct structure. We apply this procedure to some quantum kinematical algebras in (1+1) dimensions with this kind of structure: null-plane quantum Poincare algebra, non-standard quantum Galilei algebra and quantum κ-Galilei algebra

  12. Abstract Algebra to Secondary School Algebra: Building Bridges

    Science.gov (United States)

    Christy, Donna; Sparks, Rebecca

    2015-01-01

    The authors have experience with secondary mathematics teacher candidates struggling to make connections between the theoretical abstract algebra course they take as college students and the algebra they will be teaching in secondary schools. As a mathematician and a mathematics educator, the authors collaborated to create and implement a…

  13. Two-Level Hierarchical FEM Method for Modeling Passive Microwave Devices

    Science.gov (United States)

    Polstyanko, Sergey V.; Lee, Jin-Fa

    1998-03-01

    In recent years multigrid methods have been proven to be very efficient for solving large systems of linear equations resulting from the discretization of positive definite differential equations by either the finite difference method or theh-version of the finite element method. In this paper an iterative method of the multiple level type is proposed for solving systems of algebraic equations which arise from thep-version of the finite element analysis applied to indefinite problems. A two-levelV-cycle algorithm has been implemented and studied with a Gauss-Seidel iterative scheme used as a smoother. The convergence of the method has been investigated, and numerical results for a number of numerical examples are presented.

  14. Infinite dimension algebra and conformal symmetry

    International Nuclear Information System (INIS)

    Ragoucy-Aubezon, E.

    1991-04-01

    A generalisation of Kac-Moody algebras (current algebras defined on a circle) to algebras defined on a compact supermanifold of any dimension and with any number of supersymmetries is presented. For such a purpose, we compute all the central extensions of loop algebras defined on this supermanifold, i.e. all the cohomology classes of these loop algebras. Then, we try to extend the relation (i.e. semi-direct sum) that exists between the two dimensional conformal algebras (called Virasoro algebra) and the usual Kac-Moody algebras, by considering the derivation algebra of our extended Kac-Moody algebras. The case of superconformal algebras (used in superstrings theories) is treated, as well as the cases of area-preserving diffeomorphisms (used in membranes theories), and Krichever-Novikov algebras (used for interacting strings). Finally, we present some generalizations of the Sugawara construction to the cases of extended Kac-Moody algebras, and Kac-Moody of superalgebras. These constructions allow us to get new realizations of the Virasoro, and Ramond, Neveu-Schwarz algebras

  15. {sup 10}B multi-grid proportional gas counters for large area thermal neutron detectors

    Energy Technology Data Exchange (ETDEWEB)

    Andersen, K. [ESS, P.O. Box 176, SE-221 00 Lund (Sweden); Bigault, T. [ILL, BP 156, 6, rue Jules Horowitz, 38042 Grenoble Cedex 9 (France); Birch, J. [Linköping University, SE-581, 83 Linköping (Sweden); Buffet, J. C.; Correa, J. [ILL, BP 156, 6, rue Jules Horowitz, 38042 Grenoble Cedex 9 (France); Hall-Wilton, R. [ESS, P.O. Box 176, SE-221 00 Lund (Sweden); Hultman, L. [Linköping University, SE-581, 83 Linköping (Sweden); Höglund, C. [ESS, P.O. Box 176, SE-221 00 Lund (Sweden); Linköping University, SE-581, 83 Linköping (Sweden); Guérard, B., E-mail: guerard@ill.fr [ILL, BP 156, 6, rue Jules Horowitz, 38042 Grenoble Cedex 9 (France); Jensen, J. [Linköping University, SE-581, 83 Linköping (Sweden); Khaplanov, A. [ILL, BP 156, 6, rue Jules Horowitz, 38042 Grenoble Cedex 9 (France); ESS, P.O. Box 176, SE-221 00 Lund (Sweden); Kirstein, O. [Linköping University, SE-581, 83 Linköping (Sweden); Piscitelli, F.; Van Esch, P. [ILL, BP 156, 6, rue Jules Horowitz, 38042 Grenoble Cedex 9 (France); Vettier, C. [ESS, P.O. Box 176, SE-221 00 Lund (Sweden)

    2013-08-21

    {sup 3}He was a popular material in neutrons detectors until its availability dropped drastically in 2008. The development of techniques based on alternative convertors is now of high priority for neutron research institutes. Thin films of {sup 10}B or {sup 10}B{sub 4}C have been used in gas proportional counters to detect neutrons, but until now, only for small or medium sensitive area. We present here the multi-grid design, introduced at the ILL and developed in collaboration with ESS for LAN (large area neutron) detectors. Typically thirty {sup 10}B{sub 4}C films of 1 μm thickness are used to convert neutrons into ionizing particles which are subsequently detected in a proportional gas counter. The principle and the fabrication of the multi-grid are described and some preliminary results obtained with a prototype of 200 cm×8 cm are reported; a detection efficiency of 48% has been measured at 2.5 Å with a monochromatic neutron beam line, showing the good potential of this new technique.

  16. Equivalency of two-dimensional algebras

    International Nuclear Information System (INIS)

    Santos, Gildemar Carneiro dos; Pomponet Filho, Balbino Jose S.

    2011-01-01

    Full text: Let us consider a vector z = xi + yj over the field of real numbers, whose basis (i,j) satisfy a given algebra. Any property of this algebra will be reflected in any function of z, so we can state that the knowledge of the properties of an algebra leads to more general conclusions than the knowledge of the properties of a function. However structural properties of an algebra do not change when this algebra suffers a linear transformation, though the structural constants defining this algebra do change. We say that two algebras are equivalent to each other whenever they are related by a linear transformation. In this case, we have found that some relations between the structural constants are sufficient to recognize whether or not an algebra is equivalent to another. In spite that the basis transform linearly, the structural constants change like a third order tensor, but some combinations of these tensors result in a linear transformation, allowing to write the entries of the transformation matrix as function of the structural constants. Eventually, a systematic way to find the transformation matrix between these equivalent algebras is obtained. In this sense, we have performed the thorough classification of associative commutative two-dimensional algebras, and find that even non-division algebra may be helpful in solving non-linear dynamic systems. The Mandelbrot set was used to have a pictorial view of each algebra, since equivalent algebras result in the same pattern. Presently we have succeeded in classifying some non-associative two-dimensional algebras, a task more difficult than for associative one. (author)

  17. Biased Monte Carlo algorithms on unitary groups

    International Nuclear Information System (INIS)

    Creutz, M.; Gausterer, H.; Sanielevici, S.

    1989-01-01

    We introduce a general updating scheme for the simulation of physical systems defined on unitary groups, which eliminates the systematic errors due to inexact exponentiation of algebra elements. The essence is to work directly with group elements for the stochastic noise. Particular cases of the scheme include the algorithm of Metropolis et al., overrelaxation algorithms, and globally corrected Langevin and hybrid algorithms. The latter are studied numerically for the case of SU(3) theory

  18. Taming the unknown a history of algebra from antiquity to the early twentieth century

    CERN Document Server

    Katz, Victor J

    2014-01-01

    What is algebra? For some, it is an abstract language of x's and y's. For mathematics majors and professional mathematicians, it is a world of axiomatically defined constructs like groups, rings, and fields. Taming the Unknown considers how these two seemingly different types of algebra evolved and how they relate. Victor Katz and Karen Parshall explore the history of algebra, from its roots in the ancient civilizations of Egypt, Mesopotamia, Greece, China, and India, through its development in the medieval Islamic world and medieval and early modern Europe, to its modern form in the early twentieth century. Defining algebra originally as a collection of techniques for determining unknowns, the authors trace the development of these techniques from geometric beginnings in ancient Egypt and Mesopotamia and classical Greece. They show how similar problems were tackled in Alexandrian Greece, in China, and in India, then look at how medieval Islamic scholars shifted to an algorithmic stage, which was further dev...

  19. Monolithic multigrid method for the coupled Stokes flow and deformable porous medium system

    Science.gov (United States)

    Luo, P.; Rodrigo, C.; Gaspar, F. J.; Oosterlee, C. W.

    2018-01-01

    The interaction between fluid flow and a deformable porous medium is a complicated multi-physics problem, which can be described by a coupled model based on the Stokes and poroelastic equations. A monolithic multigrid method together with either a coupled Vanka smoother or a decoupled Uzawa smoother is employed as an efficient numerical technique for the linear discrete system obtained by finite volumes on staggered grids. A specialty in our modeling approach is that at the interface of the fluid and poroelastic medium, two unknowns from the different subsystems are defined at the same grid point. We propose a special discretization at and near the points on the interface, which combines the approximation of the governing equations and the considered interface conditions. In the decoupled Uzawa smoother, Local Fourier Analysis (LFA) helps us to select optimal values of the relaxation parameter appearing. To implement the monolithic multigrid method, grid partitioning is used to deal with the interface updates when communication is required between two subdomains. Numerical experiments show that the proposed numerical method has an excellent convergence rate. The efficiency and robustness of the method are confirmed in numerical experiments with typically small realistic values of the physical coefficients.

  20. An implementation of the Heaviside algorithm

    International Nuclear Information System (INIS)

    Dimovski, I.H.; Spiridonova, M.N.

    2011-01-01

    The so-called Heaviside algorithm based on the operational calculus approach is intended for solving initial value problems for linear ordinary differential equations with constant coefficients. We use it in the framework of Mikusinski's operational calculus. A description and implementation of the Heaviside algorithm using a computer algebra system are considered. Special attention is paid to the features making this implementation efficient. Illustrative examples are included

  1. Axis Problem of Rough 3-Valued Algebras

    Institute of Scientific and Technical Information of China (English)

    Jianhua Dai; Weidong Chen; Yunhe Pan

    2006-01-01

    The collection of all the rough sets of an approximation space has been given several algebraic interpretations, including Stone algebras, regular double Stone algebras, semi-simple Nelson algebras, pre-rough algebras and 3-valued Lukasiewicz algebras. A 3-valued Lukasiewicz algebra is a Stone algebra, a regular double Stone algebra, a semi-simple Nelson algebra, a pre-rough algebra. Thus, we call the algebra constructed by the collection of rough sets of an approximation space a rough 3-valued Lukasiewicz algebra. In this paper,the rough 3-valued Lukasiewicz algebras, which are a special kind of 3-valued Lukasiewicz algebras, are studied. Whether the rough 3-valued Lukasiewicz algebra is a axled 3-valued Lukasiewicz algebra is examined.

  2. Algorithms for computational fluid dynamics n parallel processors

    International Nuclear Information System (INIS)

    Van de Velde, E.F.

    1986-01-01

    A study of parallel algorithms for the numerical solution of partial differential equations arising in computational fluid dynamics is presented. The actual implementation on parallel processors of shared and nonshared memory design is discussed. The performance of these algorithms is analyzed in terms of machine efficiency, communication time, bottlenecks and software development costs. For elliptic equations, a parallel preconditioned conjugate gradient method is described, which has been used to solve pressure equations discretized with high order finite elements on irregular grids. A parallel full multigrid method and a parallel fast Poisson solver are also presented. Hyperbolic conservation laws were discretized with parallel versions of finite difference methods like the Lax-Wendroff scheme and with the Random Choice method. Techniques are developed for comparing the behavior of an algorithm on different architectures as a function of problem size and local computational effort. Effective use of these advanced architecture machines requires the use of machine dependent programming. It is shown that the portability problems can be minimized by introducing high level operations on vectors and matrices structured into program libraries

  3. Final Report of Optimization Algorithms for Hierarchical Problems, with Applications to Nanoporous Materials

    Energy Technology Data Exchange (ETDEWEB)

    Nash, Stephen G.

    2013-11-11

    The research focuses on the modeling and optimization of nanoporous materials. In systems with hierarchical structure that we consider, the physics changes as the scale of the problem is reduced and it can be important to account for physics at the fine level to obtain accurate approximations at coarser levels. For example, nanoporous materials hold promise for energy production and storage. A significant issue is the fabrication of channels within these materials to allow rapid diffusion through the material. One goal of our research is to apply optimization methods to the design of nanoporous materials. Such problems are large and challenging, with hierarchical structure that we believe can be exploited, and with a large range of important scales, down to atomistic. This requires research on large-scale optimization for systems that exhibit different physics at different scales, and the development of algorithms applicable to designing nanoporous materials for many important applications in energy production, storage, distribution, and use. Our research has two major research thrusts. The first is hierarchical modeling. We plan to develop and study hierarchical optimization models for nanoporous materials. The models have hierarchical structure, and attempt to balance the conflicting aims of model fidelity and computational tractability. In addition, we analyze the general hierarchical model, as well as the specific application models, to determine their properties, particularly those properties that are relevant to the hierarchical optimization algorithms. The second thrust was to develop, analyze, and implement a class of hierarchical optimization algorithms, and apply them to the hierarchical models we have developed. We adapted and extended the optimization-based multigrid algorithms of Lewis and Nash to the optimization models exemplified by the hierarchical optimization model. This class of multigrid algorithms has been shown to be a powerful tool for

  4. Efficient high-precision matrix algebra on parallel architectures for nonlinear combinatorial optimization

    KAUST Repository

    Gunnels, John; Lee, Jon; Margulies, Susan

    2010-01-01

    We provide a first demonstration of the idea that matrix-based algorithms for nonlinear combinatorial optimization problems can be efficiently implemented. Such algorithms were mainly conceived by theoretical computer scientists for proving efficiency. We are able to demonstrate the practicality of our approach by developing an implementation on a massively parallel architecture, and exploiting scalable and efficient parallel implementations of algorithms for ultra high-precision linear algebra. Additionally, we have delineated and implemented the necessary algorithmic and coding changes required in order to address problems several orders of magnitude larger, dealing with the limits of scalability from memory footprint, computational efficiency, reliability, and interconnect perspectives. © Springer and Mathematical Programming Society 2010.

  5. Efficient high-precision matrix algebra on parallel architectures for nonlinear combinatorial optimization

    KAUST Repository

    Gunnels, John

    2010-06-01

    We provide a first demonstration of the idea that matrix-based algorithms for nonlinear combinatorial optimization problems can be efficiently implemented. Such algorithms were mainly conceived by theoretical computer scientists for proving efficiency. We are able to demonstrate the practicality of our approach by developing an implementation on a massively parallel architecture, and exploiting scalable and efficient parallel implementations of algorithms for ultra high-precision linear algebra. Additionally, we have delineated and implemented the necessary algorithmic and coding changes required in order to address problems several orders of magnitude larger, dealing with the limits of scalability from memory footprint, computational efficiency, reliability, and interconnect perspectives. © Springer and Mathematical Programming Society 2010.

  6. Enveloping σ-C C C-algebra of a smooth Frechet algebra crossed ...

    Indian Academy of Sciences (India)

    Home; Journals; Proceedings – Mathematical Sciences; Volume 116; Issue 2. Enveloping -*-Algebra of a Smooth Frechet Algebra Crossed Product by R R , K -Theory and Differential Structure in *-Algebras. Subhash J Bhatt. Regular Articles Volume 116 Issue 2 May 2006 pp 161-173 ...

  7. Hecke algebras with unequal parameters

    CERN Document Server

    Lusztig, G

    2003-01-01

    Hecke algebras arise in representation theory as endomorphism algebras of induced representations. One of the most important classes of Hecke algebras is related to representations of reductive algebraic groups over p-adic or finite fields. In 1979, in the simplest (equal parameter) case of such Hecke algebras, Kazhdan and Lusztig discovered a particular basis (the KL-basis) in a Hecke algebra, which is very important in studying relations between representation theory and geometry of the corresponding flag varieties. It turned out that the elements of the KL-basis also possess very interesting combinatorial properties. In the present book, the author extends the theory of the KL-basis to a more general class of Hecke algebras, the so-called algebras with unequal parameters. In particular, he formulates conjectures describing the properties of Hecke algebras with unequal parameters and presents examples verifying these conjectures in particular cases. Written in the author's precise style, the book gives rese...

  8. Non-integrability of geodesic flow on certain algebraic surfaces

    International Nuclear Information System (INIS)

    Waters, T.J.

    2012-01-01

    This Letter addresses an open problem recently posed by V. Kozlov: a rigorous proof of the non-integrability of the geodesic flow on the cubic surface xyz=1. We prove this is the case using the Morales–Ramis theorem and Kovacic algorithm. We also consider some consequences and extensions of this result. -- Highlights: ► The behaviour of geodesics on surfaces defined by algebraic expressions is studied. ► The non-integrability of the geodesic equations is rigorously proved using differential Galois theory. ► Morales–Ramis theory and Kovacic's algorithm is used and the normal variational equation is of Fuchsian type. ► Some extensions and limitations are discussed.

  9. Polynomial algebra of discrete models in systems biology.

    Science.gov (United States)

    Veliz-Cuba, Alan; Jarrah, Abdul Salam; Laubenbacher, Reinhard

    2010-07-01

    An increasing number of discrete mathematical models are being published in Systems Biology, ranging from Boolean network models to logical models and Petri nets. They are used to model a variety of biochemical networks, such as metabolic networks, gene regulatory networks and signal transduction networks. There is increasing evidence that such models can capture key dynamic features of biological networks and can be used successfully for hypothesis generation. This article provides a unified framework that can aid the mathematical analysis of Boolean network models, logical models and Petri nets. They can be represented as polynomial dynamical systems, which allows the use of a variety of mathematical tools from computer algebra for their analysis. Algorithms are presented for the translation into polynomial dynamical systems. Examples are given of how polynomial algebra can be used for the model analysis. alanavc@vt.edu Supplementary data are available at Bioinformatics online.

  10. Categories and Commutative Algebra

    CERN Document Server

    Salmon, P

    2011-01-01

    L. Badescu: Sur certaines singularites des varietes algebriques.- D.A. Buchsbaum: Homological and commutative algebra.- S. Greco: Anelli Henseliani.- C. Lair: Morphismes et structures algebriques.- B.A. Mitchell: Introduction to category theory and homological algebra.- R. Rivet: Anneaux de series formelles et anneaux henseliens.- P. Salmon: Applicazioni della K-teoria all'algebra commutativa.- M. Tierney: Axiomatic sheaf theory: some constructions and applications.- C.B. Winters: An elementary lecture on algebraic spaces.

  11. Particle-like structure of Lie algebras

    Science.gov (United States)

    Vinogradov, A. M.

    2017-07-01

    If a Lie algebra structure 𝔤 on a vector space is the sum of a family of mutually compatible Lie algebra structures 𝔤i's, we say that 𝔤 is simply assembled from the 𝔤i's. Repeating this procedure with a number of Lie algebras, themselves simply assembled from the 𝔤i's, one obtains a Lie algebra assembled in two steps from 𝔤i's, and so on. We describe the process of modular disassembling of a Lie algebra into a unimodular and a non-unimodular part. We then study two inverse questions: which Lie algebras can be assembled from a given family of Lie algebras, and from which Lie algebras can a given Lie algebra be assembled. We develop some basic assembling and disassembling techniques that constitute the elements of a new approach to the general theory of Lie algebras. The main result of our theory is that any finite-dimensional Lie algebra over an algebraically closed field of characteristic zero or over R can be assembled in a finite number of steps from two elementary constituents, which we call dyons and triadons. Up to an abelian summand, a dyon is a Lie algebra structure isomorphic to the non-abelian 2-dimensional Lie algebra, while a triadon is isomorphic to the 3-dimensional Heisenberg Lie algebra. As an example, we describe constructions of classical Lie algebras from triadons.

  12. Graphs and matroids weighted in a bounded incline algebra.

    Science.gov (United States)

    Lu, Ling-Xia; Zhang, Bei

    2014-01-01

    Firstly, for a graph weighted in a bounded incline algebra (or called a dioid), a longest path problem (LPP, for short) is presented, which can be considered the uniform approach to the famous shortest path problem, the widest path problem, and the most reliable path problem. The solutions for LPP and related algorithms are given. Secondly, for a matroid weighted in a linear matroid, the maximum independent set problem is studied.

  13. Prime factorization using quantum annealing and computational algebraic geometry

    Science.gov (United States)

    Dridi, Raouf; Alghassi, Hedayat

    2017-02-01

    We investigate prime factorization from two perspectives: quantum annealing and computational algebraic geometry, specifically Gröbner bases. We present a novel autonomous algorithm which combines the two approaches and leads to the factorization of all bi-primes up to just over 200000, the largest number factored to date using a quantum processor. We also explain how Gröbner bases can be used to reduce the degree of Hamiltonians.

  14. Prime factorization using quantum annealing and computational algebraic geometry

    OpenAIRE

    Dridi, Raouf; Alghassi, Hedayat

    2017-01-01

    We investigate prime factorization from two perspectives: quantum annealing and computational algebraic geometry, specifically Gr?bner bases. We present a novel autonomous algorithm which combines the two approaches and leads to the factorization of all bi-primes up to just over 200000, the largest number factored to date using a quantum processor. We also explain how Gr?bner bases can be used to reduce the degree of Hamiltonians.

  15. Dynamical entropy of C* algebras and Von Neumann algebras

    International Nuclear Information System (INIS)

    Connes, A.; Narnhofer, H.; Thirring, W.

    1986-01-01

    The definition of the dynamical entropy is extended for automorphism groups of C * algebras. As example the dynamical entropy of the shift of a lattice algebra is studied and it is shown that in some cases it coincides with the entropy density. (Author)

  16. Gradings on simple Lie algebras

    CERN Document Server

    Elduque, Alberto

    2013-01-01

    Gradings are ubiquitous in the theory of Lie algebras, from the root space decomposition of a complex semisimple Lie algebra relative to a Cartan subalgebra to the beautiful Dempwolff decomposition of E_8 as a direct sum of thirty-one Cartan subalgebras. This monograph is a self-contained exposition of the classification of gradings by arbitrary groups on classical simple Lie algebras over algebraically closed fields of characteristic not equal to 2 as well as on some nonclassical simple Lie algebras in positive characteristic. Other important algebras also enter the stage: matrix algebras, the octonions, and the Albert algebra. Most of the presented results are recent and have not yet appeared in book form. This work can be used as a textbook for graduate students or as a reference for researchers in Lie theory and neighboring areas.

  17. Performance of direct and iterative algorithms on an optical systolic processor

    Science.gov (United States)

    Ghosh, A. K.; Casasent, D.; Neuman, C. P.

    1985-11-01

    The frequency-multiplexed optical linear algebra processor (OLAP) is treated in detail with attention to its performance in the solution of systems of linear algebraic equations (LAEs). General guidelines suitable for most OLAPs, including digital-optical processors, are advanced concerning system and component error source models, guidelines for appropriate use of direct and iterative algorithms, the dominant error sources, and the effect of multiple simultaneous error sources. Specific results are advanced on the quantitative performance of both direct and iterative algorithms in the solution of systems of LAEs and in the solution of nonlinear matrix equations. Acoustic attenuation is found to dominate iterative algorithms and detector noise to dominate direct algorithms. The effect of multiple spatial errors is found to be additive. A theoretical expression for the amount of acoustic attenuation allowed is advanced and verified. Simulations and experimental data are included.

  18. Topological conformal algebra and BRST algebra in non-critical string theories

    International Nuclear Information System (INIS)

    Fujikawa, Kazuo; Suzuki, Hiroshi.

    1991-03-01

    The operator algebra in non-critical string theories is studied by treating the cosmological term as a perturbation. The algebra of covariantly regularized BRST and related currents contains a twisted N = 2 superconformal algebra only at d = -2 in bosonic strings, and a twisted N = 3 superconformal algebra only at d = ±∞ in spinning strings. The bosonic string at d = -2 is examined by replacing the string coordinate by a fermionic matter with c = -2. The resulting bc-βγ system accommodates various forms of BRST cohomology, and the ghost number assignment and BRST cohomology are different in the c = -2 string theory and two-dimensional topological gravity. (author)

  19. Algebraic K-theory

    CERN Document Server

    Srinivas, V

    1996-01-01

    Algebraic K-Theory has become an increasingly active area of research. With its connections to algebra, algebraic geometry, topology, and number theory, it has implications for a wide variety of researchers and graduate students in mathematics. The book is based on lectures given at the author's home institution, the Tata Institute in Bombay, and elsewhere. A detailed appendix on topology was provided in the first edition to make the treatment accessible to readers with a limited background in topology. The second edition also includes an appendix on algebraic geometry that contains the required definitions and results needed to understand the core of the book; this makes the book accessible to a wider audience. A central part of the book is a detailed exposition of the ideas of Quillen as contained in his classic papers "Higher Algebraic K-Theory, I, II." A more elementary proof of the theorem of Merkujev--Suslin is given in this edition; this makes the treatment of this topic self-contained. An application ...

  20. Head First Algebra A Learner's Guide to Algebra I

    CERN Document Server

    Pilone, Tracey

    2008-01-01

    Having trouble understanding algebra? Do algebraic concepts, equations, and logic just make your head spin? We have great news: Head First Algebra is designed for you. Full of engaging stories and practical, real-world explanations, this book will help you learn everything from natural numbers and exponents to solving systems of equations and graphing polynomials. Along the way, you'll go beyond solving hundreds of repetitive problems, and actually use what you learn to make real-life decisions. Does it make sense to buy two years of insurance on a car that depreciates as soon as you drive i