WorldWideScience

Sample records for adaptive algebraic multigrid

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

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

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

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

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

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

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

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

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

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

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

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

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

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

  18. Adaptive algebraic reconstruction technique

    International Nuclear Information System (INIS)

    Lu Wenkai; Yin Fangfang

    2004-01-01

    Algebraic reconstruction techniques (ART) are iterative procedures for reconstructing objects from their projections. It is proven that ART can be computationally efficient by carefully arranging the order in which the collected data are accessed during the reconstruction procedure and adaptively adjusting the relaxation parameters. In this paper, an adaptive algebraic reconstruction technique (AART), which adopts the same projection access scheme in multilevel scheme algebraic reconstruction technique (MLS-ART), is proposed. By introducing adaptive adjustment of the relaxation parameters during the reconstruction procedure, one-iteration AART can produce reconstructions with better quality, in comparison with one-iteration MLS-ART. Furthermore, AART outperforms MLS-ART with improved computational efficiency

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

  19. The Adapted Ordering Method for Lie algebras and superalgebras and their generalizations

    Energy Technology Data Exchange (ETDEWEB)

    Gato-Rivera, Beatriz [Instituto de Matematicas y Fisica Fundamental, CSIC, Serrano 123, Madrid 28006 (Spain); NIKHEF-H, Kruislaan 409, NL-1098 SJ Amsterdam (Netherlands)

    2008-02-01

    In 1998 the Adapted Ordering Method was developed for the representation theory of the superconformal algebras in two dimensions. It allows us to determine maximal dimensions for a given type of space of singular vectors, to identify all singular vectors by only a few coefficients, to spot subsingular vectors and to set the basis for constructing embedding diagrams. In this paper we present the Adapted Ordering Method for general Lie algebras and superalgebras and their generalizations, provided they can be triangulated. We also review briefly the results obtained for the Virasoro algebra and for the N = 2 and Ramond N = 1 superconformal algebras.

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

  3. Multigrid preconditioned conjugate-gradient method for large-scale wave-front reconstruction.

    Science.gov (United States)

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

    2002-09-01

    We introduce a multigrid preconditioned conjugate-gradient (MGCG) iterative scheme for computing open-loop wave-front reconstructors for extreme adaptive optics systems. We present numerical simulations for a 17-m class telescope with n = 48756 sensor measurement grid points within the aperture, which indicate that our MGCG method has a rapid convergence rate for a wide range of subaperture average slope measurement signal-to-noise ratios. The total computational cost is of order n log n. Hence our scheme provides for fast wave-front simulation and control in large-scale adaptive optics systems.

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

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

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

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

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

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

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

  12. Algebraic and adaptive learning in neural control systems

    Science.gov (United States)

    Ferrari, Silvia

    A systematic approach is developed for designing adaptive and reconfigurable nonlinear control systems that are applicable to plants modeled by ordinary differential equations. The nonlinear controller comprising a network of neural networks is taught using a two-phase learning procedure realized through novel techniques for initialization, on-line training, and adaptive critic design. A critical observation is that the gradients of the functions defined by the neural networks must equal corresponding linear gain matrices at chosen operating points. On-line training is based on a dual heuristic adaptive critic architecture that improves control for large, coupled motions by accounting for actual plant dynamics and nonlinear effects. An action network computes the optimal control law; a critic network predicts the derivative of the cost-to-go with respect to the state. Both networks are algebraically initialized based on prior knowledge of satisfactory pointwise linear controllers and continue to adapt on line during full-scale simulations of the plant. On-line training takes place sequentially over discrete periods of time and involves several numerical procedures. A backpropagating algorithm called Resilient Backpropagation is modified and successfully implemented to meet these objectives, without excessive computational expense. This adaptive controller is as conservative as the linear designs and as effective as a global nonlinear controller. The method is successfully implemented for the full-envelope control of a six-degree-of-freedom aircraft simulation. The results show that the on-line adaptation brings about improved performance with respect to the initialization phase during aircraft maneuvers that involve large-angle and coupled dynamics, and parameter variations.

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

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

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

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

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

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

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

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

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

  2. Accuracy requirements of optical linear algebra processors in adaptive optics imaging systems

    Science.gov (United States)

    Downie, John D.; Goodman, Joseph W.

    1989-10-01

    The accuracy requirements of optical processors in adaptive optics systems are determined by estimating the required accuracy in a general optical linear algebra processor (OLAP) that results in a smaller average residual aberration than that achieved with a conventional electronic digital processor with some specific computation speed. Special attention is given to an error analysis of a general OLAP with regard to the residual aberration that is created in an adaptive mirror system by the inaccuracies of the processor, and to the effect of computational speed of an electronic processor on the correction. Results are presented on the ability of an OLAP to compete with a digital processor in various situations.

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

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

  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. Located actions in process algebra with timing

    NARCIS (Netherlands)

    Bergstra, J.A.; Middelburg, C.A.

    2004-01-01

    We propose a process algebra obtained by adapting the process algebra with continuous relative timing from Baeten and Middelburg [Process Algebra with Timing, Springer, 2002, Chap. 4] to spatially located actions. This process algebra makes it possible to deal with the behaviour of systems with a

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

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

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

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

  11. Scalable Adaptive Multilevel Solvers for Multiphysics Problems

    Energy Technology Data Exchange (ETDEWEB)

    Xu, Jinchao [Pennsylvania State Univ., University Park, PA (United States). Dept. of Mathematics

    2014-11-26

    In this project, we carried out many studies on adaptive and parallel multilevel methods for numerical modeling for various applications, including Magnetohydrodynamics (MHD) and complex fluids. We have made significant efforts and advances in adaptive multilevel methods of the multiphysics problems: multigrid methods, adaptive finite element methods, and applications.

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

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

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

  17. Finite W-algebras and intermediate statistics

    International Nuclear Information System (INIS)

    Barbarin, F.; Ragoucy, E.; Sorba, P.

    1995-01-01

    New realizations of finite W-algebras are constructed by relaxing the usual constraint conditions. Then finite W-algebras are recognized in the Heisenberg quantization recently proposed by Leinaas and Myrheim, for a system of two identical particles in d dimensions. As the anyonic parameter is directly associated to the W-algebra involved in the d=1 case, it is natural to consider that the W-algebra framework is well adapted for a possible generalization of the anyon statistics. ((orig.))

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

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

  20. Finite W-algebras and intermediate statistics

    International Nuclear Information System (INIS)

    Barbarin, F.; Ragoucy, E.; Sorba, P.

    1994-09-01

    New realizations of finite W-algebras are constructed by relaxing the usual conditions. Then finite W-algebras are recognized in the Heisenberg quantization recently proposed by Leinaas and Myrheim, for a system of two identical particles in d dimensions. As the anyonic parameter is directly associated to the W-algebra involved in the d=1 case, it is natural to consider that the W-algebra framework is well adapted for a possible generalization of the anyon statistics. (author). 13 refs

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

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

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

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

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

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

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

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

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

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

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

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

  13. Filiform Lie algebras of order 3

    Science.gov (United States)

    Navarro, R. M.

    2014-04-01

    The aim of this work is to generalize a very important type of Lie algebras and superalgebras, i.e., filiform Lie (super)algebras, into the theory of Lie algebras of order F. Thus, the concept of filiform Lie algebras of order F is obtained. In particular, for F = 3 it has been proved that by using infinitesimal deformations of the associated model elementary Lie algebra it can be obtained families of filiform elementary lie algebras of order 3, analogously as that occurs into the theory of Lie algebras [M. Vergne, "Cohomologie des algèbres de Lie nilpotentes. Application à l'étude de la variété des algèbres de Lie nilpotentes," Bull. Soc. Math. France 98, 81-116 (1970)]. Also we give the dimension, using an adaptation of the {sl}(2,{C})-module Method, and a basis of such infinitesimal deformations in some generic cases.

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

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

  16. Filiform Lie algebras of order 3

    International Nuclear Information System (INIS)

    Navarro, R. M.

    2014-01-01

    The aim of this work is to generalize a very important type of Lie algebras and superalgebras, i.e., filiform Lie (super)algebras, into the theory of Lie algebras of order F. Thus, the concept of filiform Lie algebras of order F is obtained. In particular, for F = 3 it has been proved that by using infinitesimal deformations of the associated model elementary Lie algebra it can be obtained families of filiform elementary lie algebras of order 3, analogously as that occurs into the theory of Lie algebras [M. Vergne, “Cohomologie des algèbres de Lie nilpotentes. Application à l’étude de la variété des algèbres de Lie nilpotentes,” Bull. Soc. Math. France 98, 81–116 (1970)]. Also we give the dimension, using an adaptation of the sl(2,C)-module Method, and a basis of such infinitesimal deformations in some generic cases

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

  19. Loop homotopy algebras in closed string field theory

    International Nuclear Information System (INIS)

    Markl, M.

    2001-01-01

    Barton Zwiebach (1993) constructed ''string products'' on the Hilbert space of a combined conformal field theory of matter and ghosts, satisfying the ''main identity''. It has been well known that the ''tree level'' of the theory gives an example of a strongly homotopy Lie algebra (though, as we will see later, this is not the whole truth). Strongly homotopy Lie algebras are now well-understood objects. On the one hand, strongly homotopy Lie algebra is given by a square zero coderivation on the cofree cocommutative connected coalgebra on the other hand, strongly homotopy Lie algebras are algebras over the cobar dual of the operad Com for commutative algebras. No such characterization of the structure of string products for arbitrary genera has been available, though there are two series of papers directly pointing towards the requisite characterization. As far as the characterization in terms of (co)derivations is concerned, we need the concept of higher order (co)derivations. For our characterization we need to understand the behavior of these higher (co)derivations on (co)free (co)algebras. The necessary machinery for the operadic approach is that of modular operads. We also indicate how to adapt the loop homotopy structure to the case of open string field theory. (orig.)

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

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

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

  3. Mathematics and computational methods development in U.S. department of energy-sponsored research (nuclear energy research initiative and nuclear engineering education research). 5. Analysis of Angular V-Cycle Multigrid Formulation for Three-Dimensional Discrete Ordinates Shielding Problems

    International Nuclear Information System (INIS)

    Kucukboyaci, Vefa; Haghighat, Alireza

    2001-01-01

    We have developed new angular multigrid formulations, including the Simplified Angular Multigrid (SAM), Nested Iteration (NI), and V-Cycle schemes, that are compatible with the parallel environment and the adaptive differencing strategy of the PENTRAN three-dimensional parallel S N code. Using the Fourier analysis method for an infinite, homogenous medium, we have investigated the effectiveness of the V-Cycle scheme for different problem parameters including scattering ratio, spatial differencing weights, quadrature order, and mesh size. We have further investigated the effectiveness of the new schemes for practical shielding applications such as the Kobayashi benchmark problem and the boiling water reactor core shroud problem. In this paper, we summarize the angular V-Cycle scheme implemented in the PENTRAN code, the Fourier Analysis of the V-Cycle scheme, and results of convergence analysis of the V-Cycle scheme using different problem parameters. The theoretical analysis reveals that the V-Cycle scheme is effective for a large range of scattering ratios and is insensitive to mesh size. Besides the theoretical analysis, we have applied the new angular multigrid schemes to shielding problems. In comparison to the standard PCR formulation, combinations of the new angular multigrid schemes and PCR (e.g., SAM+V-Cycle+PCR) have proved to be very effective for scattering ratios in a range of 0.6 to 0.9. (authors)

  4. Simulating streamer discharges in 3D with the parallel adaptive Afivo framework

    NARCIS (Netherlands)

    H.J. Teunissen (Jannis); U. M. Ebert (Ute)

    2017-01-01

    htmlabstractWe present an open-source plasma fluid code for 2D, cylindrical and 3D simulations of streamer discharges, based on the Afivo framework that features adaptive mesh refinement, geometric multigrid methods for Poisson's equation, and OpenMP parallelism. We describe the numerical

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

  20. Aberration studies and computer algebra

    International Nuclear Information System (INIS)

    Hawkes, P.W.

    1981-01-01

    The labour of calculating expressions for aberration coefficients is considerably lightened if a computer algebra language is used to perform the various substitutions and expansions involved. After a brief discussion of matrix representations of aberration coefficients, a particular language, which has shown itself to be well adapted to particle optics, is described and applied to the study of high frequency cavity lenses. (orig.)

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

  10. Modeling Stochastic Complexity in Complex Adaptive Systems: Non-Kolmogorov Probability and the Process Algebra Approach.

    Science.gov (United States)

    Sulis, William H

    2017-10-01

    Walter Freeman III pioneered the application of nonlinear dynamical systems theories and methodologies in his work on mesoscopic brain dynamics.Sadly, mainstream psychology and psychiatry still cling to linear correlation based data analysis techniques, which threaten to subvert the process of experimentation and theory building. In order to progress, it is necessary to develop tools capable of managing the stochastic complexity of complex biopsychosocial systems, which includes multilevel feedback relationships, nonlinear interactions, chaotic dynamics and adaptability. In addition, however, these systems exhibit intrinsic randomness, non-Gaussian probability distributions, non-stationarity, contextuality, and non-Kolmogorov probabilities, as well as the absence of mean and/or variance and conditional probabilities. These properties and their implications for statistical analysis are discussed. An alternative approach, the Process Algebra approach, is described. It is a generative model, capable of generating non-Kolmogorov probabilities. It has proven useful in addressing fundamental problems in quantum mechanics and in the modeling of developing psychosocial systems.

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

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

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

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

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

  16. Software abstractions and computational issues in parallel structure adaptive mesh methods for electronic structure calculations

    Energy Technology Data Exchange (ETDEWEB)

    Kohn, S.; Weare, J.; Ong, E.; Baden, S.

    1997-05-01

    We have applied structured adaptive mesh refinement techniques to the solution of the LDA equations for electronic structure calculations. Local spatial refinement concentrates memory resources and numerical effort where it is most needed, near the atomic centers and in regions of rapidly varying charge density. The structured grid representation enables us to employ efficient iterative solver techniques such as conjugate gradient with FAC multigrid preconditioning. We have parallelized our solver using an object- oriented adaptive mesh refinement framework.

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

  1. Mastering algebra retrains the visual system to perceive hierarchical structure in equations.

    Science.gov (United States)

    Marghetis, Tyler; Landy, David; Goldstone, Robert L

    2016-01-01

    Formal mathematics is a paragon of abstractness. It thus seems natural to assume that the mathematical expert should rely more on symbolic or conceptual processes, and less on perception and action. We argue instead that mathematical proficiency relies on perceptual systems that have been retrained to implement mathematical skills. Specifically, we investigated whether the visual system-in particular, object-based attention-is retrained so that parsing algebraic expressions and evaluating algebraic validity are accomplished by visual processing. Object-based attention occurs when the visual system organizes the world into discrete objects, which then guide the deployment of attention. One classic signature of object-based attention is better perceptual discrimination within, rather than between, visual objects. The current study reports that object-based attention occurs not only for simple shapes but also for symbolic mathematical elements within algebraic expressions-but only among individuals who have mastered the hierarchical syntax of algebra. Moreover, among these individuals, increased object-based attention within algebraic expressions is associated with a better ability to evaluate algebraic validity. These results suggest that, in mastering the rules of algebra, people retrain their visual system to represent and evaluate abstract mathematical structure. We thus argue that algebraic expertise involves the regimentation and reuse of evolutionarily ancient perceptual processes. Our findings implicate the visual system as central to learning and reasoning in mathematics, leading us to favor educational approaches to mathematics and related STEM fields that encourage students to adapt, not abandon, their use of perception.

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

  8. Developing Pre-Algebraic Thinking in Generalizing Repeating Pattern Using SOLO Model

    Science.gov (United States)

    Lian, Lim Hooi; Yew, Wun Thiam

    2011-01-01

    In this paper, researchers discussed the application of the generalization perspective in helping the primary school pupils to develop their pre-algebraic thinking in generalizing repeating pattern. There are two main stages of the generalization perspective had been adapted, namely investigating and generalizing the pattern. Since the Biggs and…

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

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

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

  12. Novikov algebras with associative bilinear forms

    Energy Technology Data Exchange (ETDEWEB)

    Zhu Fuhai; Chen Zhiqi [School of Mathematical Sciences and LPMC, Nankai University, Tianjin 300071 (China)

    2007-11-23

    Novikov algebras were introduced in connection with the Poisson brackets of hydrodynamic-type and Hamiltonian operators in formal variational calculus. The goal of this paper is to study Novikov algebras with non-degenerate associative symmetric bilinear forms, which we call quadratic Novikov algebras. Based on the classification of solvable quadratic Lie algebras of dimension not greater than 4 and Novikov algebras in dimension 3, we show that quadratic Novikov algebras up to dimension 4 are commutative. Furthermore, we obtain the classification of transitive quadratic Novikov algebras in dimension 4. But we find that not every quadratic Novikov algebra is commutative and give a non-commutative quadratic Novikov algebra in dimension 6.

  13. Lie algebra in quantum physics by means of computer algebra

    OpenAIRE

    Kikuchi, Ichio; Kikuchi, Akihito

    2017-01-01

    This article explains how to apply the computer algebra package GAP (www.gap-system.org) in the computation of the problems in quantum physics, in which the application of Lie algebra is necessary. The article contains several exemplary computations which readers would follow in the desktop PC: such as, the brief review of elementary ideas of Lie algebra, the angular momentum in quantum mechanics, the quark eight-fold way model, and the usage of Weyl character formula (in order to construct w...

  14. Fast multigrid solution of the advection problem with closed characteristics

    Energy Technology Data Exchange (ETDEWEB)

    Yavneh, I. [Israel Inst. of Technology, Haifa (Israel); Venner, C.H. [Univ. of Twente, Enschede (Netherlands); Brandt, A. [Weizmann Inst. of Science, Rehovot (Israel)

    1996-12-31

    The numerical solution of the advection-diffusion problem in the inviscid limit with closed characteristics is studied as a prelude to an efficient high Reynolds-number flow solver. It is demonstrated by a heuristic analysis and numerical calculations that using upstream discretization with downstream relaxation-ordering and appropriate residual weighting in a simple multigrid V cycle produces an efficient solution process. We also derive upstream finite-difference approximations to the advection operator, whose truncation terms approximate {open_quotes}physical{close_quotes} (Laplacian) viscosity, thus avoiding spurious solutions to the homogeneous problem when the artificial diffusivity dominates the physical viscosity.

  15. Tensor spaces and exterior algebra

    CERN Document Server

    Yokonuma, Takeo

    1992-01-01

    This book explains, as clearly as possible, tensors and such related topics as tensor products of vector spaces, tensor algebras, and exterior algebras. You will appreciate Yokonuma's lucid and methodical treatment of the subject. This book is useful in undergraduate and graduate courses in multilinear algebra. Tensor Spaces and Exterior Algebra begins with basic notions associated with tensors. To facilitate understanding of the definitions, Yokonuma often presents two or more different ways of describing one object. Next, the properties and applications of tensors are developed, including the classical definition of tensors and the description of relative tensors. Also discussed are the algebraic foundations of tensor calculus and applications of exterior algebra to determinants and to geometry. This book closes with an examination of algebraic systems with bilinear multiplication. In particular, Yokonuma discusses the theory of replicas of Chevalley and several properties of Lie algebras deduced from them.

  16. Profinite algebras and affine boundedness

    OpenAIRE

    Schneider, Friedrich Martin; Zumbrägel, Jens

    2015-01-01

    We prove a characterization of profinite algebras, i.e., topological algebras that are isomorphic to a projective limit of finite discrete algebras. In general profiniteness concerns both the topological and algebraic characteristics of a topological algebra, whereas for topological groups, rings, semigroups, and distributive lattices, profiniteness turns out to be a purely topological property as it is is equivalent to the underlying topological space being a Stone space. Condensing the core...

  17. Double-partition Quantum Cluster Algebras

    DEFF Research Database (Denmark)

    Jakobsen, Hans Plesner; Zhang, Hechun

    2012-01-01

    A family of quantum cluster algebras is introduced and studied. In general, these algebras are new, but sub-classes have been studied previously by other authors. The algebras are indexed by double parti- tions or double flag varieties. Equivalently, they are indexed by broken lines L. By grouping...... together neighboring mutations into quantum line mutations we can mutate from the cluster algebra of one broken line to another. Compatible pairs can be written down. The algebras are equal to their upper cluster algebras. The variables of the quantum seeds are given by elements of the dual canonical basis....

  18. Algebra II workbook for dummies

    CERN Document Server

    Sterling, Mary Jane

    2014-01-01

    To succeed in Algebra II, start practicing now Algebra II builds on your Algebra I skills to prepare you for trigonometry, calculus, and a of myriad STEM topics. Working through practice problems helps students better ingest and retain lesson content, creating a solid foundation to build on for future success. Algebra II Workbook For Dummies, 2nd Edition helps you learn Algebra II by doing Algebra II. Author and math professor Mary Jane Sterling walks you through the entire course, showing you how to approach and solve the problems you encounter in class. You'll begin by refreshing your Algebr

  19. Very true operators on MTL-algebras

    Directory of Open Access Journals (Sweden)

    Wang Jun Tao

    2016-01-01

    Full Text Available The main goal of this paper is to investigate very true MTL-algebras and prove the completeness of the very true MTL-logic. In this paper, the concept of very true operators on MTL-algebras is introduced and some related properties are investigated. Also, conditions for an MTL-algebra to be an MV-algebra and a Gödel algebra are given via this operator. Moreover, very true filters on very true MTL-algebras are studied. In particular, subdirectly irreducible very true MTL-algebras are characterized and an analogous of representation theorem for very true MTL-algebras is proved. Then, the left and right stabilizers of very true MTL-algebras are introduced and some related properties are given. As applications of stabilizer of very true MTL-algebras, we produce a basis for a topology on very true MTL-algebras and show that the generated topology by this basis is Baire, connected, locally connected and separable. Finally, the corresponding logic very true MTL-logic is constructed and the soundness and completeness of this logic are proved based on very true MTL-algebras.

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

  1. Higher-order ice-sheet modelling accelerated by multigrid on graphics cards

    Science.gov (United States)

    Brædstrup, Christian; Egholm, David

    2013-04-01

    Higher-order ice flow modelling is a very computer intensive process owing primarily to the nonlinear influence of the horizontal stress coupling. When applied for simulating long-term glacial landscape evolution, the ice-sheet models must consider very long time series, while both high temporal and spatial resolution is needed to resolve small effects. The use of higher-order and full stokes models have therefore seen very limited usage in this field. However, recent advances in graphics card (GPU) technology for high performance computing have proven extremely efficient in accelerating many large-scale scientific computations. The general purpose GPU (GPGPU) technology is cheap, has a low power consumption and fits into a normal desktop computer. It could therefore provide a powerful tool for many glaciologists working on ice flow models. Our current research focuses on utilising the GPU as a tool in ice-sheet and glacier modelling. To this extent we have implemented the Integrated Second-Order Shallow Ice Approximation (iSOSIA) equations on the device using the finite difference method. To accelerate the computations, the GPU solver uses a non-linear Red-Black Gauss-Seidel iterator coupled with a Full Approximation Scheme (FAS) multigrid setup to further aid convergence. The GPU finite difference implementation provides the inherent parallelization that scales from hundreds to several thousands of cores on newer cards. We demonstrate the efficiency of the GPU multigrid solver using benchmark experiments.

  2. Hopf algebras in noncommutative geometry

    International Nuclear Information System (INIS)

    Varilly, Joseph C.

    2001-10-01

    We give an introductory survey to the use of Hopf algebras in several problems of non- commutative geometry. The main example, the Hopf algebra of rooted trees, is a graded, connected Hopf algebra arising from a universal construction. We show its relation to the algebra of transverse differential operators introduced by Connes and Moscovici in order to compute a local index formula in cyclic cohomology, and to the several Hopf algebras defined by Connes and Kreimer to simplify the combinatorics of perturbative renormalization. We explain how characteristic classes for a Hopf module algebra can be obtained from the cyclic cohomology of the Hopf algebra which acts on it. Finally, we discuss the theory of non- commutative spherical manifolds and show how they arise as homogeneous spaces of certain compact quantum groups. (author)

  3. W-realization of Lie algebras. Application to so(4,2) and Poincare algebras

    International Nuclear Information System (INIS)

    Barbarin, F.; Ragoucy, E.; Sorba, P.

    1996-05-01

    The property of some finite W-algebras to appear as the commutant of a particular subalgebra in a simple Lie algebra G is exploited for the obtention of new G-realizations from a 'canonical' differential one. The method is applied to the conformal algebra so(4,2) and therefore yields also results for its Poincare subalgebra. Unitary irreducible representations of these algebras are recognized in this approach, which is naturally compared -or associated to - the induced representation technique. (author)

  4. Extended Kac-Moody algebras and applications

    International Nuclear Information System (INIS)

    Ragoucy, E.; Sorba, P.

    1991-04-01

    The notion of a Kac-Moody algebra defined on the S 1 circle is extended to super Kac-Moody algebras defined on MxG N , M being a smooth closed compact manifold of dimension greater than one, and G N the Grassman algebra with N generators. All the central extensions of these algebras are computed. Then, for each such algebra the derivation algebra constructed from the MxG N diffeomorphism is determined. The twists of such super Kac-Moody algebras as well as the generalization to non-compact surfaces are partially studied. Finally, the general construction is applied to the study of conformal and superconformal algebras, as well as area-preserving diffeomorphisms algebra and its supersymmetric extension. (author) 65 refs

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

  6. Lie algebras and applications

    CERN Document Server

    Iachello, Francesco

    2015-01-01

    This course-based primer provides an introduction to Lie algebras and some of their applications to the spectroscopy of molecules, atoms, nuclei and hadrons. In the first part, it concisely presents the basic concepts of Lie algebras, their representations and their invariants. The second part includes a description of how Lie algebras are used in practice in the treatment of bosonic and fermionic systems. Physical applications considered include rotations and vibrations of molecules (vibron model), collective modes in nuclei (interacting boson model), the atomic shell model, the nuclear shell model, and the quark model of hadrons. One of the key concepts in the application of Lie algebraic methods in physics, that of spectrum generating algebras and their associated dynamic symmetries, is also discussed. The book highlights a number of examples that help to illustrate the abstract algebraic definitions and includes a summary of many formulas of practical interest, such as the eigenvalues of Casimir operators...

  7. (Fuzzy) Ideals of BN-Algebras

    Science.gov (United States)

    Walendziak, Andrzej

    2015-01-01

    The notions of an ideal and a fuzzy ideal in BN-algebras are introduced. The properties and characterizations of them are investigated. The concepts of normal ideals and normal congruences of a BN-algebra are also studied, the properties of them are displayed, and a one-to-one correspondence between them is presented. Conditions for a fuzzy set to be a fuzzy ideal are given. The relationships between ideals and fuzzy ideals of a BN-algebra are established. The homomorphic properties of fuzzy ideals of a BN-algebra are provided. Finally, characterizations of Noetherian BN-algebras and Artinian BN-algebras via fuzzy ideals are obtained. PMID:26125050

  8. A matrix-free implicit unstructured multigrid finite volume method for simulating structural dynamics and fluid structure interaction

    Science.gov (United States)

    Lv, X.; Zhao, Y.; Huang, X. Y.; Xia, G. H.; Su, X. H.

    2007-07-01

    A new three-dimensional (3D) matrix-free implicit unstructured multigrid finite volume (FV) solver for structural dynamics is presented in this paper. The solver is first validated using classical 2D and 3D cantilever problems. It is shown that very accurate predictions of the fundamental natural frequencies of the problems can be obtained by the solver with fast convergence rates. This method has been integrated into our existing FV compressible solver [X. Lv, Y. Zhao, et al., An efficient parallel/unstructured-multigrid preconditioned implicit method for simulating 3d unsteady compressible flows with moving objects, Journal of Computational Physics 215(2) (2006) 661-690] based on the immersed membrane method (IMM) [X. Lv, Y. Zhao, et al., as mentioned above]. Results for the interaction between the fluid and an immersed fixed-free cantilever are also presented to demonstrate the potential of this integrated fluid-structure interaction approach.

  9. Non-relativistic Bondi-Metzner-Sachs algebra

    Science.gov (United States)

    Batlle, Carles; Delmastro, Diego; Gomis, Joaquim

    2017-09-01

    We construct two possible candidates for non-relativistic bms4 algebra in four space-time dimensions by contracting the original relativistic bms4 algebra. bms4 algebra is infinite-dimensional and it contains the generators of the Poincaré algebra, together with the so-called super-translations. Similarly, the proposed nrbms4 algebras can be regarded as two infinite-dimensional extensions of the Bargmann algebra. We also study a canonical realization of one of these algebras in terms of the Fourier modes of a free Schrödinger field, mimicking the canonical realization of relativistic bms4 algebra using a free Klein-Gordon field.

  10. The Unitality of Quantum B-algebras

    Science.gov (United States)

    Han, Shengwei; Xu, Xiaoting; Qin, Feng

    2018-02-01

    Quantum B-algebras as a generalization of quantales were introduced by Rump and Yang, which cover the majority of implicational algebras and provide a unified semantic for a wide class of substructural logics. Unital quantum B-algebras play an important role in the classification of implicational algebras. The main purpose of this paper is to construct unital quantum B-algebras from non-unital quantum B-algebras.

  11. On Weak-BCC-Algebras

    Science.gov (United States)

    Thomys, Janus; Zhang, Xiaohong

    2013-01-01

    We describe weak-BCC-algebras (also called BZ-algebras) in which the condition (x∗y)∗z = (x∗z)∗y is satisfied only in the case when elements x, y belong to the same branch. We also characterize ideals, nilradicals, and nilpotent elements of such algebras. PMID:24311983

  12. G-identities of non-associative algebras

    International Nuclear Information System (INIS)

    Bakhturin, Yu A; Zaitsev, M V; Sehgal, S K

    1999-01-01

    The main class of algebras considered in this paper is the class of algebras of Lie type. This class includes, in particular, associative algebras, Lie algebras and superalgebras, Leibniz algebras, quantum Lie algebras, and many others. We prove that if a finite group G acts on such an algebra A by automorphisms and anti-automorphisms and A satisfies an essential G-identity, then A satisfies an ordinary identity of degree bounded by a function that depends on the degree of the original identity and the order of G. We show in the case of ordinary Lie algebras that if L is a Lie algebra, a finite group G acts on L by automorphisms and anti-automorphisms, and the order of G is coprime to the characteristic of the field, then the existence of an identity on skew-symmetric elements implies the existence of an identity on the whole of L, with the same kind of dependence between the degrees of the identities. Finally, we generalize Amitsur's theorem on polynomial identities in associative algebras with involution to the case of alternative algebras with involution

  13. h-multigrid agglomeration based solution strategies for discontinuous Galerkin discretizations of incompressible flow problems

    Science.gov (United States)

    Botti, L.; Colombo, A.; Bassi, F.

    2017-10-01

    In this work we exploit agglomeration based h-multigrid preconditioners to speed-up the iterative solution of discontinuous Galerkin discretizations of the Stokes and Navier-Stokes equations. As a distinctive feature h-coarsened mesh sequences are generated by recursive agglomeration of a fine grid, admitting arbitrarily unstructured grids of complex domains, and agglomeration based discontinuous Galerkin discretizations are employed to deal with agglomerated elements of coarse levels. Both the expense of building coarse grid operators and the performance of the resulting multigrid iteration are investigated. For the sake of efficiency coarse grid operators are inherited through element-by-element L2 projections, avoiding the cost of numerical integration over agglomerated elements. Specific care is devoted to the projection of viscous terms discretized by means of the BR2 dG method. We demonstrate that enforcing the correct amount of stabilization on coarse grids levels is mandatory for achieving uniform convergence with respect to the number of levels. The numerical solution of steady and unsteady, linear and non-linear problems is considered tackling challenging 2D test cases and 3D real life computations on parallel architectures. Significant execution time gains are documented.

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

  15. W-realization of Lie algebras. Application to so(4,2) and Poincare algebras

    Energy Technology Data Exchange (ETDEWEB)

    Barbarin, F.; Ragoucy, E.; Sorba, P.

    1996-05-01

    The property of some finite W-algebras to appear as the commutant of a particular subalgebra in a simple Lie algebra G is exploited for the obtention of new G-realizations from a `canonical` differential one. The method is applied to the conformal algebra so(4,2) and therefore yields also results for its Poincare subalgebra. Unitary irreducible representations of these algebras are recognized in this approach, which is naturally compared -or associated to - the induced representation technique. (author). 12 refs.

  16. On Dunkl angular momenta algebra

    Energy Technology Data Exchange (ETDEWEB)

    Feigin, Misha [School of Mathematics and Statistics, University of Glasgow,15 University Gardens, Glasgow G12 8QW (United Kingdom); Hakobyan, Tigran [Yerevan State University,1 Alex Manoogian, 0025 Yerevan (Armenia); Tomsk Polytechnic University,Lenin Ave. 30, 634050 Tomsk (Russian Federation)

    2015-11-17

    We consider the quantum angular momentum generators, deformed by means of the Dunkl operators. Together with the reflection operators they generate a subalgebra in the rational Cherednik algebra associated with a finite real reflection group. We find all the defining relations of the algebra, which appear to be quadratic, and we show that the algebra is of Poincaré-Birkhoff-Witt (PBW) type. We show that this algebra contains the angular part of the Calogero-Moser Hamiltonian and that together with constants it generates the centre of the algebra. We also consider the gl(N) version of the subalgebra of the rational Cherednik algebra and show that it is a non-homogeneous quadratic algebra of PBW type as well. In this case the central generator can be identified with the usual Calogero-Moser Hamiltonian associated with the Coxeter group in the harmonic confinement.

  17. Algebraic computing

    International Nuclear Information System (INIS)

    MacCallum, M.A.H.

    1990-01-01

    The implementation of a new computer algebra system is time consuming: designers of general purpose algebra systems usually say it takes about 50 man-years to create a mature and fully functional system. Hence the range of available systems and their capabilities changes little between one general relativity meeting and the next, despite which there have been significant changes in the period since the last report. The introductory remarks aim to give a brief survey of capabilities of the principal available systems and highlight one or two trends. The reference to the most recent full survey of computer algebra in relativity and brief descriptions of the Maple, REDUCE and SHEEP and other applications are given. (author)

  18. Automatic mesh refinement and local multigrid methods for contact problems: application to the Pellet-Cladding mechanical Interaction

    International Nuclear Information System (INIS)

    Liu, Hao

    2016-01-01

    This Ph.D. work takes place within the framework of studies on Pellet-Cladding mechanical Interaction (PCI) which occurs in the fuel rods of pressurized water reactor. This manuscript focuses on automatic mesh refinement to simulate more accurately this phenomena while maintaining acceptable computational time and memory space for industrial calculations. An automatic mesh refinement strategy based on the combination of the Local Defect Correction multigrid method (LDC) with the Zienkiewicz and Zhu a posteriori error estimator is proposed. The estimated error is used to detect the zones to be refined, where the local sub-grids of the LDC method are generated. Several stopping criteria are studied to end the refinement process when the solution is accurate enough or when the refinement does not improve the global solution accuracy anymore. Numerical results for elastic 2D test cases with pressure discontinuity show the efficiency of the proposed strategy. The automatic mesh refinement in case of unilateral contact problems is then considered. The strategy previously introduced can be easily adapted to the multi-body refinement by estimating solution error on each body separately. Post-processing is often necessary to ensure the conformity of the refined areas regarding the contact boundaries. A variety of numerical experiments with elastic contact (with or without friction, with or without an initial gap) confirms the efficiency and adaptability of the proposed strategy. (author) [fr

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

  20. Connections between algebra, combinatorics, and geometry

    CERN Document Server

    Sather-Wagstaff, Sean

    2014-01-01

    Commutative algebra, combinatorics, and algebraic geometry are thriving areas of mathematical research with a rich history of interaction. Connections Between Algebra, Combinatorics, and Geometry contains lecture notes, along with exercises and solutions, from the Workshop on Connections Between Algebra and Geometry held at the University of Regina from May 29-June 1, 2012. It also contains research and survey papers from academics invited to participate in the companion Special Session on Interactions Between Algebraic Geometry and Commutative Algebra, which was part of the CMS Summer Meeting at the University of Regina held June 2–3, 2012, and the meeting Further Connections Between Algebra and Geometry, which was held at the North Dakota State University, February 23, 2013. This volume highlights three mini-courses in the areas of commutative algebra and algebraic geometry: differential graded commutative algebra, secant varieties, and fat points and symbolic powers. It will serve as a useful resou...

  1. Abstract algebra for physicists

    International Nuclear Information System (INIS)

    Zeman, J.

    1975-06-01

    Certain recent models of composite hadrons involve concepts and theorems from abstract algebra which are unfamiliar to most theoretical physicists. The algebraic apparatus needed for an understanding of these models is summarized here. Particular emphasis is given to algebraic structures which are not assumed to be associative. (2 figures) (auth)

  2. Basic notions of algebra

    CERN Document Server

    Shafarevich, Igor Rostislavovich

    2005-01-01

    This book is wholeheartedly recommended to every student or user of mathematics. Although the author modestly describes his book as 'merely an attempt to talk about' algebra, he succeeds in writing an extremely original and highly informative essay on algebra and its place in modern mathematics and science. From the fields, commutative rings and groups studied in every university math course, through Lie groups and algebras to cohomology and category theory, the author shows how the origins of each algebraic concept can be related to attempts to model phenomena in physics or in other branches

  3. Characterizations of locally C*-algebras

    International Nuclear Information System (INIS)

    Mohammad, N.; Somasundaram, S.

    1991-08-01

    We seek the generalization of the Gelfand-Naimark theorems for locally C*-algebras. Precisely, if A is a unital commutative locally C*-algebra, then it is shown that A is *-isomorphic (topologically and algebraically) to C(Δ). Further, if A is any locally C*-algebra, then it is realized as a closed *-subalgebra of some L(H) up to a topological algebraic *-isomorphism. Also, a brief exposition of the Gelfand-Naimark-Segal construction is given and some of its consequences are discussed. (author). 16 refs

  4. Galois Theory of Differential Equations, Algebraic Groups and Lie Algebras

    NARCIS (Netherlands)

    Put, Marius van der

    1999-01-01

    The Galois theory of linear differential equations is presented, including full proofs. The connection with algebraic groups and their Lie algebras is given. As an application the inverse problem of differential Galois theory is discussed. There are many exercises in the text.

  5. Brauer algebras of type B

    NARCIS (Netherlands)

    Cohen, A.M.; Liu, S.

    2011-01-01

    For each n>0, we define an algebra having many properties that one might expect to hold for a Brauer algebra of type Bn. It is defined by means of a presentation by generators and relations. We show that this algebra is a subalgebra of the Brauer algebra of type Dn+1 and point out a cellular

  6. Design and fabrication of multigrid X-ray collimators. [For airborne x-ray spectroscopy

    Energy Technology Data Exchange (ETDEWEB)

    Acton, L W; Joki, E G; Salmon, R J [Lockheed Missiles and Space Co., Palo Alto, Calif. (USA). Lockheed Palo Alto Research Lab.

    1976-08-01

    Multigrid X-ray collimators continue to find wide application in space research. This paper treats the principles of their design and fabrication and summarizes the experience obtained in making and flying thirteen such collimators ranging in angular resolution from 10 to 0.7 arc min FWHM. Included is a summary of a survey of scientist-users and industrial producers of collimator grids regarding grid materials, precision, plating, hole quality and results of acceptance testing.

  7. A course in BE-algebras

    CERN Document Server

    Mukkamala, Sambasiva Rao

    2018-01-01

    This book presents a unified course in BE-algebras with a comprehensive introduction, general theoretical basis and several examples. It introduces the general theoretical basis of BE-algebras, adopting a credible style to offer students a conceptual understanding of the subject. BE-algebras are important tools for certain investigations in algebraic logic, because they can be considered as fragments of any propositional logic containing a logical connective implication and the constant "1", which is considered as the logical value “true”.  Primarily aimed at graduate and postgraduate students of mathematics, it also helps researchers and mathematicians to build a strong foundation in applied abstract algebra. Presenting insights into some of the abstract thinking that constitutes modern abstract algebra, it provides a transition from elementary topics to advanced topics in BE-algebras. With abundant examples and exercises arranged after each section, it offers readers a comprehensive, easy-to-follow int...

  8. On Associative Conformal Algebras of Linear Growth

    OpenAIRE

    Retakh, Alexander

    2000-01-01

    Lie conformal algebras appear in the theory of vertex algebras. Their relation is similar to that of Lie algebras and their universal enveloping algebras. Associative conformal algebras play a role in conformal representation theory. We introduce the notions of conformal identity and unital associative conformal algebras and classify finitely generated simple unital associative conformal algebras of linear growth. These are precisely the complete algebras of conformal endomorphisms of finite ...

  9. The Linear Span of Projections in AH Algebras and for Inclusions of C*-Algebras

    Directory of Open Access Journals (Sweden)

    Dinh Trung Hoa

    2013-01-01

    Full Text Available In the first part of this paper, we show that an AH algebra A=lim→(Ai,ϕi has the LP property if and only if every element of the centre of Ai belongs to the closure of the linear span of projections in A. As a consequence, a diagonal AH-algebra has the LP property if it has small eigenvalue variation in the sense of Bratteli and Elliott. The second contribution of this paper is that for an inclusion of unital C*-algebras P⊂A with a finite Watatani index, if a faithful conditional expectation E:A→P has the Rokhlin property in the sense of Kodaka et al., then P has the LP property under the condition thatA has the LP property. As an application, let A be a simple unital C*-algebra with the LP property, α an action of a finite group G onto Aut(A. If α has the Rokhlin property in the sense of Izumi, then the fixed point algebra AG and the crossed product algebra A ⋊α G have the LP property. We also point out that there is a symmetry on the CAR algebra such that its fixed point algebra does not have the LP property.

  10. Non-commutative multiple-valued logic algebras

    CERN Document Server

    Ciungu, Lavinia Corina

    2014-01-01

    This monograph provides a self-contained and easy-to-read introduction to non-commutative multiple-valued logic algebras; a subject which has attracted much interest in the past few years because of its impact on information science, artificial intelligence and other subjects.   A study of the newest results in the field, the monograph includes treatment of pseudo-BCK algebras, pseudo-hoops, residuated lattices, bounded divisible residuated lattices, pseudo-MTL algebras, pseudo-BL algebras and pseudo-MV algebras. It provides a fresh perspective on new trends in logic and algebras in that algebraic structures can be developed into fuzzy logics which connect quantum mechanics, mathematical logic, probability theory, algebra and soft computing.   Written in a clear, concise and direct manner, Non-Commutative Multiple-Valued Logic Algebras will be of interest to masters and PhD students, as well as researchers in mathematical logic and theoretical computer science.

  11. Automorphic Lie algebras with dihedral symmetry

    International Nuclear Information System (INIS)

    Knibbeler, V; Lombardo, S; A Sanders, J

    2014-01-01

    The concept of automorphic Lie algebras arises in the context of reduction groups introduced in the early 1980s in the field of integrable systems. automorphic Lie algebras are obtained by imposing a discrete group symmetry on a current algebra of Krichever–Novikov type. Past work shows remarkable uniformity between algebras associated to different reduction groups. For example, if the base Lie algebra is sl 2 (C) and the poles of the automorphic Lie algebra are restricted to an exceptional orbit of the symmetry group, changing the reduction group does not affect the Lie algebra structure. In this research we fix the reduction group to be the dihedral group and vary the orbit of poles as well as the group action on the base Lie algebra. We find a uniform description of automorphic Lie algebras with dihedral symmetry, valid for poles at exceptional and generic orbits. (paper)

  12. Certain number-theoretic episodes in algebra

    CERN Document Server

    Sivaramakrishnan, R

    2006-01-01

    Many basic ideas of algebra and number theory intertwine, making it ideal to explore both at the same time. Certain Number-Theoretic Episodes in Algebra focuses on some important aspects of interconnections between number theory and commutative algebra. Using a pedagogical approach, the author presents the conceptual foundations of commutative algebra arising from number theory. Self-contained, the book examines situations where explicit algebraic analogues of theorems of number theory are available. Coverage is divided into four parts, beginning with elements of number theory and algebra such as theorems of Euler, Fermat, and Lagrange, Euclidean domains, and finite groups. In the second part, the book details ordered fields, fields with valuation, and other algebraic structures. This is followed by a review of fundamentals of algebraic number theory in the third part. The final part explores links with ring theory, finite dimensional algebras, and the Goldbach problem.

  13. Fusion rules of chiral algebras

    International Nuclear Information System (INIS)

    Gaberdiel, M.

    1994-01-01

    Recently we showed that for the case of the WZW and the minimal models fusion can be understood as a certain ring-like tensor product of the symmetry algebra. In this paper we generalize this analysis to arbitrary chiral algebras. We define the tensor product of conformal field theory in the general case and prove that it is associative and symmetric up to equivalence. We also determine explicitly the action of the chiral algebra on this tensor product. In the second part of the paper we demonstrate that this framework provides a powerful tool for calculating restrictions for the fusion rules of chiral algebras. We exhibit this for the case of the W 3 algebra and the N=1 and N=2 NS superconformal algebras. (orig.)

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

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

  16. Coset realization of unifying W-algebras

    International Nuclear Information System (INIS)

    Blumenhagen, R.; Huebel, R.

    1994-06-01

    We construct several quantum coset W-algebras, e.g. sl(2,R)/U(1) and sl(2,R)+sl(2,R)/sl(2,R), and argue that they are finitely nonfreely generated. Furthermore, we discuss in detail their role as unifying W-algebras of Casimir W-algebras. We show that it is possible to give coset realizations of various types of unifying W-algebras, e.g. the diagonal cosets based on the symplectic Lie algebras sp(2n) realize the unifying W-algebras which have previously been introduced as 'WD -n '. In addition, minimal models of WD -n are studied. The coset realizations provide a generalization of level-rank-duality of dual coset pairs. As further examples of finitely nonfreely generated quantum W-algebras we discuss orbifolding of W-algebras which on the quantum level has different properties than in the classical case. We demonstrate in some examples that the classical limit according to Bowcock and Watts of these nonfreely finitely generated quantum W-algebras probably yields infinitely nonfreely generated classical W-algebras. (orig.)

  17. Algebra

    CERN Document Server

    Sepanski, Mark R

    2010-01-01

    Mark Sepanski's Algebra is a readable introduction to the delightful world of modern algebra. Beginning with concrete examples from the study of integers and modular arithmetic, the text steadily familiarizes the reader with greater levels of abstraction as it moves through the study of groups, rings, and fields. The book is equipped with over 750 exercises suitable for many levels of student ability. There are standard problems, as well as challenging exercises, that introduce students to topics not normally covered in a first course. Difficult problems are broken into manageable subproblems

  18. Identities and derivations for Jacobian algebras

    International Nuclear Information System (INIS)

    Dzhumadil'daev, A.S.

    2001-09-01

    Constructions of n-Lie algebras by strong n-Lie-Poisson algebras are given. First cohomology groups of adjoint module of Jacobian algebras are calculated. Minimal identities of 3-Jacobian algebra are found. (author)

  19. Situating the Debate on "Geometrical Algebra" within the Framework of Premodern Algebra.

    Science.gov (United States)

    Sialaros, Michalis; Christianidis, Jean

    2016-06-01

    Argument The aim of this paper is to employ the newly contextualized historiographical category of "premodern algebra" in order to revisit the arguably most controversial topic of the last decades in the field of Greek mathematics, namely the debate on "geometrical algebra." Within this framework, we shift focus from the discrepancy among the views expressed in the debate to some of the historiographical assumptions and methodological approaches that the opposing sides shared. Moreover, by using a series of propositions related to Elem. II.5 as a case study, we discuss Euclid's geometrical proofs, the so-called "semi-algebraic" alternative demonstrations attributed to Heron of Alexandria, as well as the solutions given by Diophantus, al-Sulamī, and al-Khwārizmī to the corresponding numerical problem. This comparative analysis offers a new reading of Heron's practice, highlights the significance of contextualizing "premodern algebra," and indicates that the origins of algebraic reasoning should be sought in the problem-solving practice, rather than in the theorem-proving tradition.

  20. Cohomology of Effect Algebras

    Directory of Open Access Journals (Sweden)

    Frank Roumen

    2017-01-01

    Full Text Available We will define two ways to assign cohomology groups to effect algebras, which occur in the algebraic study of quantum logic. The first way is based on Connes' cyclic cohomology. The resulting cohomology groups are related to the state space of the effect algebra, and can be computed using variations on the Kunneth and Mayer-Vietoris sequences. The second way involves a chain complex of ordered abelian groups, and gives rise to a cohomological characterization of state extensions on effect algebras. This has applications to no-go theorems in quantum foundations, such as Bell's theorem.

  1. Topology general & algebraic

    CERN Document Server

    Chatterjee, D

    2007-01-01

    About the Book: This book provides exposition of the subject both in its general and algebraic aspects. It deals with the notions of topological spaces, compactness, connectedness, completeness including metrizability and compactification, algebraic aspects of topological spaces through homotopy groups and homology groups. It begins with the basic notions of topological spaces but soon going beyond them reaches the domain of algebra through the notions of homotopy, homology and cohomology. How these approaches work in harmony is the subject matter of this book. The book finally arrives at the

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

  3. Graded associative conformal algebras of finite type

    OpenAIRE

    Kolesnikov, Pavel

    2011-01-01

    In this paper, we consider graded associative conformal algebras. The class of these objects includes pseudo-algebras over non-cocommutative Hopf algebras of regular functions on some linear algebraic groups. In particular, an associative conformal algebra which is graded by a finite group $\\Gamma $ is a pseudo-algebra over the coordinate Hopf algebra of a linear algebraic group $G$ such that the identity component $G^0$ is the affine line and $G/G^0\\simeq \\Gamma $. A classification of simple...

  4. Principles of linear algebra with Mathematica

    CERN Document Server

    Shiskowski, Kenneth M

    2013-01-01

    A hands-on introduction to the theoretical and computational aspects of linear algebra using Mathematica® Many topics in linear algebra are simple, yet computationally intensive, and computer algebra systems such as Mathematica® are essential not only for learning to apply the concepts to computationally challenging problems, but also for visualizing many of the geometric aspects within this field of study. Principles of Linear Algebra with Mathematica uniquely bridges the gap between beginning linear algebra and computational linear algebra that is often encountered in applied settings,

  5. Einstein algebras and general relativity

    International Nuclear Information System (INIS)

    Heller, M.

    1992-01-01

    A purely algebraic structure called an Einstein algebra is defined in such a way that every spacetime satisfying Einstein's equations is an Einstein algebra but not vice versa. The Gelfand representation of Einstein algebras is defined, and two of its subrepresentations are discussed. One of them is equivalent to the global formulation of the standard theory of general relativity; the other one leads to a more general theory of gravitation which, in particular, includes so-called regular singularities. In order to include other types of singularities one must change to sheaves of Einstein algebras. They are defined and briefly discussed. As a test of the proposed method, the sheaf of Einstein algebras corresponding to the space-time of a straight cosmic string with quasiregular singularity is constructed. 22 refs

  6. A Modified Approach to Team-Based Learning in Linear Algebra Courses

    Science.gov (United States)

    Nanes, Kalman M.

    2014-01-01

    This paper documents the author's adaptation of team-based learning (TBL), an active learning pedagogy developed by Larry Michaelsen and others, in the linear algebra classroom. The paper discusses the standard components of TBL and the necessary changes to those components for the needs of the course in question. There is also an empirically…

  7. Analytic real algebras.

    Science.gov (United States)

    Seo, Young Joo; Kim, Young Hee

    2016-01-01

    In this paper we construct some real algebras by using elementary functions, and discuss some relations between several axioms and its related conditions for such functions. We obtain some conditions for real-valued functions to be a (edge) d -algebra.

  8. Biderivations of W-algebra $W(2,2)$ and Virasoro algebra without skewsymmetric condition and their applications

    OpenAIRE

    Tang, Xiaomin

    2016-01-01

    In this paper, we characterize the biderivations of W-algebra $W(2,2)$ and Virasoro algebra $Vir$ without skewsymmetric condition. We get two classes of non-inner biderivations. As applications, we also get the forms of linear commuting maps on W-algebra $W(2,2)$ and Virasoro algebra $Vir$.

  9. Evolution algebras generated by Gibbs measures

    International Nuclear Information System (INIS)

    Rozikov, Utkir A.; Tian, Jianjun Paul

    2009-03-01

    In this article we study algebraic structures of function spaces defined by graphs and state spaces equipped with Gibbs measures by associating evolution algebras. We give a constructive description of associating evolution algebras to the function spaces (cell spaces) defined by graphs and state spaces and Gibbs measure μ. For finite graphs we find some evolution subalgebras and other useful properties of the algebras. We obtain a structure theorem for evolution algebras when graphs are finite and connected. We prove that for a fixed finite graph, the function spaces have a unique algebraic structure since all evolution algebras are isomorphic to each other for whichever Gibbs measures are assigned. When graphs are infinite graphs then our construction allows a natural introduction of thermodynamics in studying of several systems of biology, physics and mathematics by theory of evolution algebras. (author)

  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. Classical algebraic chromodynamics

    International Nuclear Information System (INIS)

    Adler, S.L.

    1978-01-01

    I develop an extension of the usual equations of SU(n) chromodynamics which permits the consistent introduction of classical, noncommuting quark source charges. The extension involves adding a singlet gluon, giving a U(n) -based theory with outer product P/sup a/(u,v) = (1/2)(d/sup a/bc + if/sup a/bc)(u/sup b/v/sup c/ - v/sup b/u/sup c/) which obeys the Jacobi identity, inner product S (u,v) = (1/2)(u/sup a/v/sup a/ + v/sup a/u/sup a/), and with the n 2 gluon fields elevated to algebraic fields over the quark color charge C* algebra. I show that provided the color charge algebra satisfies the condition S (P (u,v),w) = S (u,P (v,w)) for all elements u,v,w of the algebra, all the standard derivations of Lagrangian chromodynamics continue to hold in the algebraic chromodynamics case. I analyze in detail the color charge algebra in the two-particle (qq, qq-bar, q-barq-bar) case and show that the above consistency condition is satisfied for the following unique (and, interestingly, asymmetric) choice of quark and antiquark charges: Q/sup a//sub q/ = xi/sup a/, Q/sup a//sub q/ = xi-bar/sup a/ + delta/sup a/0(n/2)/sup 3/2/1, with xi/sup a/xi/sup b/ = (1/2)(d/sup a/bc + if/sup a/bc) xi/sup c/, xi-bar/sup a/xi-bar/sup b/ = -(1/2)(d/sup a/bc - if/sup a/bc) xi-bar/sup c/. The algebraic structure of the two-particle U(n) force problem, when expressed on an appropriately diagonalized basis, leads for all n to a classical dynamics problem involving an ordinary SU(2) Yang-Mills field with uniquely specified classical source charges which are nonparallel in the color-singlet state. An explicit calculation shows that local algebraic U(n) gauge transformations lead only to a rigid global rotation of axes in the overlying classical SU(2) problem, which implies that the relative orientations of the classical source charges have physical significance

  12. On the classification of quantum W-algebras

    International Nuclear Information System (INIS)

    Bowcock, P.; Watts, G.T.M.

    1992-01-01

    In this paper we consider the structure of general quantum W-algebras. We introduce the notions of deformability, positive-definiteness, and reductivity of a W-algebra. We show that one can associate a reductive finite Lie algebra to each reductive W-algebra. The finite Lie algebra is also endowed with a preferred sl(2) subalgebra, which gives the conformal weights of the W-algebra. We extend this to cover W-algebras containing both bosonic and fermionic fields, and illustrate our ideas with the Poisson bracket algebras of generalised Drinfeld-Sokolov hamiltonian systems. We then discuss the possibilities of classifying deformable W-algebras which fall outside this class in the context of automorphisms of Lie algebras. In conclusion we list the cases in which the W-algebra has no weight-one fields, and further, those in which it has only one weight-two field. (orig.)

  13. Lie-Algebras. Pt. 1

    International Nuclear Information System (INIS)

    Baeuerle, G.G.A.; Kerf, E.A. de

    1990-01-01

    The structure of the laws in physics is largely based on symmetries. This book is on Lie algebras, the mathematics of symmetry. It gives a thorough mathematical treatment of finite dimensional Lie algebras and Kac-Moody algebras. Concepts such as Cartan matrix, root system, Serre's construction are carefully introduced. Although the book can be read by an undergraduate with only an elementary knowledge of linear algebra, the book will also be of use to the experienced researcher. Experience has shown that students who followed the lectures are well-prepared to take on research in the realms of string-theory, conformal field-theory and integrable systems. 48 refs.; 66 figs.; 3 tabs

  14. Semiprojectivity of universal -algebras generated by algebraic elements

    DEFF Research Database (Denmark)

    Shulman, Tatiana

    2012-01-01

    Let be a polynomial in one variable whose roots all have multiplicity more than 1. It is shown that the universal -algebra of a relation , , is semiprojective and residually finite-dimensional. Applications to polynomially compact operators are given.......Let be a polynomial in one variable whose roots all have multiplicity more than 1. It is shown that the universal -algebra of a relation , , is semiprojective and residually finite-dimensional. Applications to polynomially compact operators are given....

  15. The formal theory of Hopf algebras part II: the case of Hopf algebras ...

    African Journals Online (AJOL)

    The category HopfR of Hopf algebras over a commutative unital ring R is analyzed with respect to its categorical properties. The main results are: (1) For every ring R the category HopfR is locally presentable, it is coreflective in the category of bialgebras over R, over every R-algebra there exists a cofree Hopf algebra. (2) If ...

  16. Macdonald index and chiral algebra

    Science.gov (United States)

    Song, Jaewon

    2017-08-01

    For any 4d N = 2 SCFT, there is a subsector described by a 2d chiral algebra. The vacuum character of the chiral algebra reproduces the Schur index of the corresponding 4d theory. The Macdonald index counts the same set of operators as the Schur index, but the former has one more fugacity than the latter. We conjecture a prescription to obtain the Macdonald index from the chiral algebra. The vacuum module admits a filtration, from which we construct an associated graded vector space. From this grading, we conjecture a notion of refined character for the vacuum module of a chiral algebra, which reproduces the Macdonald index. We test this prescription for the Argyres-Douglas theories of type ( A 1 , A 2 n ) and ( A 1 , D 2 n+1) where the chiral algebras are given by Virasoro and \\widehat{su}(2) affine Kac-Moody algebra. When the chiral algebra has more than one family of generators, our prescription requires a knowledge of the generators from the 4d.

  17. Vertex algebras and mirror symmetry

    International Nuclear Information System (INIS)

    Borisov, L.A.

    2001-01-01

    Mirror Symmetry for Calabi-Yau hypersurfaces in toric varieties is by now well established. However, previous approaches to it did not uncover the underlying reason for mirror varieties to be mirror. We are able to calculate explicitly vertex algebras that correspond to holomorphic parts of A and B models of Calabi-Yau hypersurfaces and complete intersections in toric varieties. We establish the relation between these vertex algebras for mirror Calabi-Yau manifolds. This should eventually allow us to rewrite the whole story of toric mirror symmetry in the language of sheaves of vertex algebras. Our approach is purely algebraic and involves simple techniques from toric geometry and homological algebra, as well as some basic results of the theory of vertex algebras. Ideas of this paper may also be useful in other problems related to maps from curves to algebraic varieties.This paper could also be of interest to physicists, because it contains explicit description of holomorphic parts of A and B models of Calabi-Yau hypersurfaces and complete intersections in terms of free bosons and fermions. (orig.)

  18. Advanced modern algebra part 2

    CERN Document Server

    Rotman, Joseph J

    2017-01-01

    This book is the second part of the new edition of Advanced Modern Algebra (the first part published as Graduate Studies in Mathematics, Volume 165). Compared to the previous edition, the material has been significantly reorganized and many sections have been rewritten. The book presents many topics mentioned in the first part in greater depth and in more detail. The five chapters of the book are devoted to group theory, representation theory, homological algebra, categories, and commutative algebra, respectively. The book can be used as a text for a second abstract algebra graduate course, as a source of additional material to a first abstract algebra graduate course, or for self-study.

  19. A q-deformed Lorentz algebra

    International Nuclear Information System (INIS)

    Schmidke, W.B.; Wess, J.; Muenchen Univ.; Zumino, B.; Lawrence Berkeley Lab., CA

    1991-01-01

    We derive a q-deformed version of the Lorentz algebra by deformating the algebra SL(2, C). The method is based on linear representations of the algebra on the complex quantum spinor space. We find that the generators usually identified with SL q (2, C) generate SU q (2) only. Four additional generators are added which generate Lorentz boosts. The full algebra of all seven generators and their coproduct is presented. We show that in the limit q→1 the generators are those of the classical Lorentz algebra plus an additional U(1). Thus we have a deformation of SL(2, C)xU(1). (orig.)

  20. Introduction to algebraic quantum field theory

    International Nuclear Information System (INIS)

    Horuzhy, S.S.

    1990-01-01

    This volume presents a systematic introduction to the algebraic approach to quantum field theory. The structure of the contents corresponds to the way the subject has advanced. It is shown how the algebraic approach has developed from the purely axiomatic theory of observables via superselection rules into the dynamical formalism of fields and observables. Chapter one discusses axioms and their consequences -many of which are now classical theorems- and deals, in general, with the axiomatic theory of local observable algebras. The absence of field concepts makes this theory incomplete and, in chapter two, superselection rules are shown to be the key to the reconstruction of fields from observables. Chapter three deals with the algebras of Wightman fields, first unbounded operator algebras, then Von Neumann field algebras (with a special section on wedge region algebras) and finally local algebras of free and generalised free fields. (author). 447 refs.; 4 figs

  1. Comments on N=4 superconformal algebras

    International Nuclear Information System (INIS)

    Rasmussen, J.

    2001-01-01

    We present a new and asymmetric N=4 superconformal algebra for arbitrary central charge, thus completing our recent work on its classical analogue with vanishing central charge. Besides the Virasoro generator and 4 supercurrents, the algebra consists of an internal SU(2)xU(1) Kac-Moody algebra in addition to two spin 1/2 fermions and a bosonic scalar. The algebra is shown to be invariant under a linear twist of the generators, except for a unique value of the continuous twist parameter. At this value, the invariance is broken and the algebra collapses to the small N=4 superconformal algebra. The asymmetric N=4 superconformal algebra may be seen as induced by an affine SL(2 vertical bar 2) current superalgebra. Replacing SL(2 vertical bar 2) with the coset SL(2 vertical bar 2)/U(1), results directly in the small N=4 superconformal algebra

  2. The theory of algebraic numbers

    CERN Document Server

    Pollard, Harry

    1998-01-01

    An excellent introduction to the basics of algebraic number theory, this concise, well-written volume examines Gaussian primes; polynomials over a field; algebraic number fields; and algebraic integers and integral bases. After establishing a firm introductory foundation, the text explores the uses of arithmetic in algebraic number fields; the fundamental theorem of ideal theory and its consequences; ideal classes and class numbers; and the Fermat conjecture. 1975 edition. References. List of Symbols. Index.

  3. Quantum Heisenberg groups and Sklyanin algebras

    International Nuclear Information System (INIS)

    Andruskiewitsch, N.; Devoto, J.; Tiraboschi, A.

    1993-05-01

    We define new quantizations of the Heisenberg group by introducing new quantizations in the universal enveloping algebra of its Lie algebra. Matrix coefficients of the Stone-von Neumann representation are preserved by these new multiplications on the algebra of functions on the Heisenberg group. Some of the new quantizations provide also a new multiplication in the algebra of theta functions; we obtain in this way Sklyanin algebras. (author). 23 refs

  4. Classification of simple flexible Lie-admissible algebras

    International Nuclear Information System (INIS)

    Okubo, S.; Myung, H.C.

    1979-01-01

    Let A be a finite-dimensional flexible Lie-admissible algebra over the complex field such that A - is a simple Lie algebra. It is shown that either A is itself a Lie algebra isomorphic to A - or A - is a Lie algebra of type A/sub n/ (n greater than or equal to 2). In the latter case, A is isomorphic to the algebra defined on the space of (n + 1) x (n + 1) traceless matrices with multiplication given by x * y = μxy + (1 - μ)yx - (1/(n + 100 Tr (xy) E where μ is a fixed scalar, xy denotes the matrix operators in Lie algebras which has been studied in theoretical physics. We also discuss a broader class of Lie algebras over arbitrary field of characteristic not equal to 2, called quasi-classical, which includes semisimple as well as reductive Lie algebras. For this class of Lie algebras, we can introduce a multiplication which makes the adjoint operator space into an associative algebra. When L is a Lie algebra with nondegenerate killing form, it is shown that the adjoint operator algebra of L in the adjoint representation becomes a commutative associative algebra with unit element and its dimension is 1 or 2 if L is simple over the complex field. This is related to the known result that a Lie algebra of type A/sub n/ (n greater than or equal to 2) alone has a nonzero completely symmetric adjoint operator in the adjoint representation while all other algebras have none. Finally, Lie-admissible algebras associated with bilinear form are investigated

  5. Quantitative Algebraic Reasoning

    DEFF Research Database (Denmark)

    Mardare, Radu Iulian; Panangaden, Prakash; Plotkin, Gordon

    2016-01-01

    We develop a quantitative analogue of equational reasoning which we call quantitative algebra. We define an equality relation indexed by rationals: a =ε b which we think of as saying that “a is approximately equal to b up to an error of ε”. We have 4 interesting examples where we have a quantitative...... equational theory whose free algebras correspond to well known structures. In each case we have finitary and continuous versions. The four cases are: Hausdorff metrics from quantitive semilattices; pWasserstein metrics (hence also the Kantorovich metric) from barycentric algebras and also from pointed...

  6. Anyons, deformed oscillator algebras and projectors

    International Nuclear Information System (INIS)

    Engquist, Johan

    2009-01-01

    We initiate an algebraic approach to the many-anyon problem based on deformed oscillator algebras. The formalism utilizes a generalization of the deformed Heisenberg algebras underlying the operator solution of the Calogero problem. We define a many-body Hamiltonian and an angular momentum operator which are relevant for a linearized analysis in the statistical parameter ν. There exists a unique ground state and, in spite of the presence of defect lines, the anyonic weight lattices are completely connected by the application of the oscillators of the algebra. This is achieved by supplementing the oscillator algebra with a certain projector algebra.

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

  8. Alternative algebraic approaches in quantum chemistry

    International Nuclear Information System (INIS)

    Mezey, Paul G.

    2015-01-01

    Various algebraic approaches of quantum chemistry all follow a common principle: the fundamental properties and interrelations providing the most essential features of a quantum chemical representation of a molecule or a chemical process, such as a reaction, can always be described by algebraic methods. Whereas such algebraic methods often provide precise, even numerical answers, nevertheless their main role is to give a framework that can be elaborated and converted into computational methods by involving alternative mathematical techniques, subject to the constraints and directions provided by algebra. In general, algebra describes sets of interrelations, often phrased in terms of algebraic operations, without much concern with the actual entities exhibiting these interrelations. However, in many instances, the very realizations of two, seemingly unrelated algebraic structures by actual quantum chemical entities or properties play additional roles, and unexpected connections between different algebraic structures are often giving new insight. Here we shall be concerned with two alternative algebraic structures: the fundamental group of reaction mechanisms, based on the energy-dependent topology of potential energy surfaces, and the interrelations among point symmetry groups for various distorted nuclear arrangements of molecules. These two, distinct algebraic structures provide interesting interrelations, which can be exploited in actual studies of molecular conformational and reaction processes. Two relevant theorems will be discussed

  9. Alternative algebraic approaches in quantum chemistry

    Energy Technology Data Exchange (ETDEWEB)

    Mezey, Paul G., E-mail: paul.mezey@gmail.com [Canada Research Chair in Scientific Modeling and Simulation, Department of Chemistry and Department of Physics and Physical Oceanography, Memorial University of Newfoundland, 283 Prince Philip Drive, St. John' s, NL A1B 3X7 (Canada)

    2015-01-22

    Various algebraic approaches of quantum chemistry all follow a common principle: the fundamental properties and interrelations providing the most essential features of a quantum chemical representation of a molecule or a chemical process, such as a reaction, can always be described by algebraic methods. Whereas such algebraic methods often provide precise, even numerical answers, nevertheless their main role is to give a framework that can be elaborated and converted into computational methods by involving alternative mathematical techniques, subject to the constraints and directions provided by algebra. In general, algebra describes sets of interrelations, often phrased in terms of algebraic operations, without much concern with the actual entities exhibiting these interrelations. However, in many instances, the very realizations of two, seemingly unrelated algebraic structures by actual quantum chemical entities or properties play additional roles, and unexpected connections between different algebraic structures are often giving new insight. Here we shall be concerned with two alternative algebraic structures: the fundamental group of reaction mechanisms, based on the energy-dependent topology of potential energy surfaces, and the interrelations among point symmetry groups for various distorted nuclear arrangements of molecules. These two, distinct algebraic structures provide interesting interrelations, which can be exploited in actual studies of molecular conformational and reaction processes. Two relevant theorems will be discussed.

  10. On graded algebras of global dimension 3

    International Nuclear Information System (INIS)

    Piontkovskii, D I

    2001-01-01

    Assume that a graded associative algebra A over a field k is minimally presented as the quotient algebra of a free algebra F by the ideal I generated by a set f of homogeneous elements. We study the following two extensions of A: the algebra F-bar=F/I oplus I/I 2 oplus ... associated with F with respect to the I-adic filtration, and the homology algebra H of the Shafarevich complex Sh(f,F) (which is a non-commutative version of the Koszul complex). We obtain several characterizations of algebras of global dimension 3. In particular, the A-algebra H in this case is free, and the algebra F-bar is isomorphic to the quotient algebra of a free A-algebra by the ideal generated by a so-called strongly free (or inert) set

  11. Unipotent and nilpotent classes in simple algebraic groups and lie algebras

    CERN Document Server

    Liebeck, Martin W

    2012-01-01

    This book concerns the theory of unipotent elements in simple algebraic groups over algebraically closed or finite fields, and nilpotent elements in the corresponding simple Lie algebras. These topics have been an important area of study for decades, with applications to representation theory, character theory, the subgroup structure of algebraic groups and finite groups, and the classification of the finite simple groups. The main focus is on obtaining full information on class representatives and centralizers of unipotent and nilpotent elements. Although there is a substantial literature on this topic, this book is the first single source where such information is presented completely in all characteristics. In addition, many of the results are new--for example, those concerning centralizers of nilpotent elements in small characteristics. Indeed, the whole approach, while using some ideas from the literature, is novel, and yields many new general and specific facts concerning the structure and embeddings of...

  12. Elements of mathematics algebra

    CERN Document Server

    Bourbaki, Nicolas

    2003-01-01

    This is a softcover reprint of the English translation of 1990 of the revised and expanded version of Bourbaki's, Algèbre, Chapters 4 to 7 (1981). This completes Algebra, 1 to 3, by establishing the theories of commutative fields and modules over a principal ideal domain. Chapter 4 deals with polynomials, rational fractions and power series. A section on symmetric tensors and polynomial mappings between modules, and a final one on symmetric functions, have been added. Chapter 5 was entirely rewritten. After the basic theory of extensions (prime fields, algebraic, algebraically closed, radical extension), separable algebraic extensions are investigated, giving way to a section on Galois theory. Galois theory is in turn applied to finite fields and abelian extensions. The chapter then proceeds to the study of general non-algebraic extensions which cannot usually be found in textbooks: p-bases, transcendental extensions, separability criterions, regular extensions. Chapter 6 treats ordered groups and fields and...

  13. Brauer algebra of type F4

    NARCIS (Netherlands)

    Liu, S.

    2012-01-01

    We present an algebra related to the Coxeter group of type F4 which can be viewed as the Brauer algebra of type F4 and is obtained as a subalgebra of the Brauer algebra of type E6. We also describe some properties of this algebra.

  14. Brauer algebras of type F4

    NARCIS (Netherlands)

    Liu, S.

    2013-01-01

    We present an algebra related to the Coxeter group of type F4 which can be viewed as the Brauer algebra of type F4 and is obtained as a subalgebra of the Brauer algebra of type E6. We also describe some properties of this algebra.

  15. New examples of continuum graded Lie algebras

    International Nuclear Information System (INIS)

    Savel'ev, M.V.

    1989-01-01

    Several new examples of continuum graded Lie algebras which provide an additional elucidation of these algebras are given. Here, in particular, the Kac-Moody algebras, the algebra S 0 Diff T 2 of infinitesimal area-preserving diffeomorphisms of the torus T 2 , the Fairlie, Fletcher and Zachos sine-algebras, etc., are described as special cases of the cross product Lie algebras. 8 refs

  16. Generalized Galilean algebras and Newtonian gravity

    Science.gov (United States)

    González, N.; Rubio, G.; Salgado, P.; Salgado, S.

    2016-04-01

    The non-relativistic versions of the generalized Poincaré algebras and generalized AdS-Lorentz algebras are obtained. These non-relativistic algebras are called, generalized Galilean algebras of type I and type II and denoted by GBn and GLn respectively. Using a generalized Inönü-Wigner contraction procedure we find that the generalized Galilean algebras of type I can be obtained from the generalized Galilean algebras type II. The S-expansion procedure allows us to find the GB5 algebra from the Newton Hooke algebra with central extension. The procedure developed in Ref. [1] allows us to show that the nonrelativistic limit of the five dimensional Einstein-Chern-Simons gravity is given by a modified version of the Poisson equation. The modification could be compatible with the effects of Dark Matter, which leads us to think that Dark Matter can be interpreted as a non-relativistic limit of Dark Energy.

  17. Circle Maps and C*-algebras

    DEFF Research Database (Denmark)

    Schmidt, Thomas Lundsgaard

    such a map, generalising the transformation groupoid of a local homeomorphism first introduced by Renault in \\cite{re}. We conduct a detailed study of the relationship between the dynamics of $\\phi$, the properties of these groupoids, the structure of their corresponding reduced groupoid $C^*$-algebras, and......, for certain classes of maps, the K-theory of these algebras. When the map $\\phi$ is transitive, we show that the algebras $C^*_r(\\Gamma_\\phi)$ and $C^*_r(\\Gamma_\\phi^+)$ are purely infinite and satisfy the Universal Coefficient Theorem. Furthermore, we find necessary and sufficient conditions for simplicity...... of these algebras in terms of dynamical properties of $\\phi$. We proceed to consider the situation when the algebras are non-simple, and describe the primitive ideal spectrum in this case. We prove that any irreducible representation factors through the $C^*$-algebra of the reduction of the groupoid to the orbit...

  18. The Boolean algebra of Galois algebras

    Directory of Open Access Journals (Sweden)

    Lianyong Xue

    2003-02-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 each g∈G, and BJg=Beg for a central idempotent eg, Ba the Boolean algebra generated by {0,eg|g∈G}, e a nonzero element in Ba, and He={g∈G|eeg=e}. Then, a monomial e is characterized, and the Galois extension Be, generated by e with Galois group He, is investigated.

  19. Geometry of Spin: Clifford Algebraic Approach

    Indian Academy of Sciences (India)

    Then the various algebraic properties of Pauli matricesare studied as properties of matrix algebra. What has beenshown in this article is that Pauli matrices are a representationof Clifford algebra of spin and hence all the propertiesof Pauli matrices follow from the underlying algebra. Cliffordalgebraic approach provides a ...

  20. Differential operators and W-algebra

    International Nuclear Information System (INIS)

    Vaysburd, I.; Radul, A.

    1992-01-01

    The connection between W-algebras and the algebra of differential operators is conjectured. The bosonized representation of the differential operator algebra with c=-2n and all the subalgebras are examined. The degenerate representations and null-state classifications for c=-2 are presented. (orig.)

  1. Donaldson invariants in algebraic geometry

    International Nuclear Information System (INIS)

    Goettsche, L.

    2000-01-01

    In these lectures I want to give an introduction to the relation of Donaldson invariants with algebraic geometry: Donaldson invariants are differentiable invariants of smooth compact 4-manifolds X, defined via moduli spaces of anti-self-dual connections. If X is an algebraic surface, then these moduli spaces can for a suitable choice of the metric be identified with moduli spaces of stable vector bundles on X. This can be used to compute Donaldson invariants via methods of algebraic geometry and has led to a lot of activity on moduli spaces of vector bundles and coherent sheaves on algebraic surfaces. We will first recall the definition of the Donaldson invariants via gauge theory. Then we will show the relation between moduli spaces of anti-self-dual connections and moduli spaces of vector bundles on algebraic surfaces, and how this makes it possible to compute Donaldson invariants via algebraic geometry methods. Finally we concentrate on the case that the number b + of positive eigenvalues of the intersection form on the second homology of the 4-manifold is 1. In this case the Donaldson invariants depend on the metric (or in the algebraic geometric case on the polarization) via a system of walls and chambers. We will study the change of the invariants under wall-crossing, and use this in particular to compute the Donaldson invariants of rational algebraic surfaces. (author)

  2. Fractional supersymmetry and infinite dimensional lie algebras

    International Nuclear Information System (INIS)

    Rausch de Traubenberg, M.

    2001-01-01

    In an earlier work extensions of supersymmetry and super Lie algebras were constructed consistently starting from any representation D of any Lie algebra g. Here it is shown how infinite dimensional Lie algebras appear naturally within the framework of fractional supersymmetry. Using a differential realization of g this infinite dimensional Lie algebra, containing the Lie algebra g as a sub-algebra, is explicitly constructed

  3. Quantum algebra of N superspace

    International Nuclear Information System (INIS)

    Hatcher, Nicolas; Restuccia, A.; Stephany, J.

    2007-01-01

    We identify the quantum algebra of position and momentum operators for a quantum system bearing an irreducible representation of the super Poincare algebra in the N>1 and D=4 superspace, both in the case where there are no central charges in the algebra, and when they are present. This algebra is noncommutative for the position operators. We use the properties of superprojectors acting on the superfields to construct explicit position and momentum operators satisfying the algebra. They act on the projected wave functions associated to the various supermultiplets with defined superspin present in the representation. We show that the quantum algebra associated to the massive superparticle appears in our construction and is described by a supermultiplet of superspin 0. This result generalizes the construction for D=4, N=1 reported recently. For the case N=2 with central charges, we present the equivalent results when the central charge and the mass are different. For the κ-symmetric case when these quantities are equal, we discuss the reduction to the physical degrees of freedom of the corresponding superparticle and the construction of the associated quantum algebra

  4. Symmetry chains and adaptation coefficients

    International Nuclear Information System (INIS)

    Fritzer, H.P.; Gruber, B.

    1985-01-01

    Given a symmetry chain of physical significance it becomes necessary to obtain states which transform properly with respect to the symmetries of the chain. In this article we describe a method which permits us to calculate symmetry-adapted quantum states with relative ease. The coefficients for the symmetry-adapted linear combinations are obtained, in numerical form, in terms of the original states of the system and can thus be represented in the form of numerical tables. In addition, one also obtains automatically the matrix elements for the operators of the symmetry groups which are involved, and thus for any physical operator which can be expressed either as an element of the algebra or of the enveloping algebra. The method is well suited for computers once the physically relevant symmetry chain, or chains, have been defined. While the method to be described is generally applicable to any physical system for which semisimple Lie algebras play a role we choose here a familiar example in order to illustrate the method and to illuminate its simplicity. We choose the nuclear shell model for the case of two nucleons with orbital angular momentum l = 1. While the states of the entire shell transform like the smallest spin representation of SO(25) we restrict our attention to its subgroup SU(6) x SU(2)/sub T/. We determine the symmetry chains which lead to total angular momentum SU(2)/sub J/ and obtain the symmetry-adapted states for these chains

  5. On criteria for algebraic independence of collections of functions satisfying algebraic difference relations

    Directory of Open Access Journals (Sweden)

    Hiroshi Ogawara

    2017-01-01

    Full Text Available This paper gives conditions for algebraic independence of a collection of functions satisfying a certain kind of algebraic difference relations. As applications, we show algebraic independence of two collections of special functions: (1 Vignéras' multiple gamma functions and derivatives of the gamma function, (2 the logarithmic function, \\(q\\-exponential functions and \\(q\\-polylogarithm functions. In a similar way, we give a generalization of Ostrowski's theorem.

  6. An algebra of reversible computation.

    Science.gov (United States)

    Wang, Yong

    2016-01-01

    We design an axiomatization for reversible computation called reversible ACP (RACP). It has four extendible modules: basic reversible processes algebra, algebra of reversible communicating processes, recursion and abstraction. Just like process algebra ACP in classical computing, RACP can be treated as an axiomatization foundation for reversible computation.

  7. On an extension of the Weil algebra

    International Nuclear Information System (INIS)

    Palev, Ch.

    An extension of the Weil algebra Wsub(n), generated by an appropriate topology is considered. The topology is introduced in such a way that algebraic operations in Wsub(n) to be continuous. The algebraic operations in Wsub(n) are extended by a natural way to a complement, which is noted as an extended Weil algebra. It turns out that the last algebra contains isomorphically the Heisenberg group. By the same way an arbitrary enveloping algebra of a Lie group may be extended. The extended algebra will contain the initial Lie group. (S.P.)

  8. Exponentiation and deformations of Lie-admissible algebras

    International Nuclear Information System (INIS)

    Myung, H.C.

    1982-01-01

    The exponential function is defined for a finite-dimensional real power-associative algebra with unit element. The application of the exponential function is focused on the power-associative (p,q)-mutation of a real or complex associative algebra. Explicit formulas are computed for the (p,q)-mutation of the real envelope of the spin 1 algebra and the Lie algebra so(3) of the rotation group, in light of earlier investigations of the spin 1/2. A slight variant of the mutated exponential is interpreted as a continuous function of the Lie algebra into some isotope of the corresponding linear Lie group. The second part of this paper is concerned with the representation and deformation of a Lie-admissible algebra. The second cohomology group of a Lie-admissible algebra is introduced as a generalization of those of associative and Lie algebras in the Hochschild and Chevalley-Eilenberg theory. Some elementary theory of algebraic deformation of Lie-admissible algebras is discussed in view of generalization of that of associative and Lie algebras. Lie-admissible deformations are also suggested by the representation of Lie-admissible algebras. Some explicit examples of Lie-admissible deformation are given in terms of the (p,q)-mutation of associative deformation of an associative algebra. Finally, we discuss Lie-admissible deformations of order one

  9. Singular dimensions of the N=2 superconformal algebras II: The twisted N=2 algebra

    International Nuclear Information System (INIS)

    Doerrzapf, M.; Gato-Rivera, B.

    2001-01-01

    We introduce a suitable adapted ordering for the twisted N=2 superconformal algebra (i.e. with mixed boundary conditions for the fermionic fields). We show that the ordering kernels for complete Verma modules have two elements and the ordering kernels for G-closed Verma modules just one. Therefore, spaces of singular vectors may be two-dimensional for complete Verma modules whilst for G-closed Verma modules they can only be one-dimensional. We give all singular vectors for the levels (1)/(2), 1, and (3)/(2) for both complete Verma modules and G-closed Verma modules. We also give explicite examples of degenerate cases with two-dimensional singular vector spaces in complete Verma modules. General expressions are conjectured for the relevant terms of all (primitive) singular vectors, i.e. for the coefficients with respect to the ordering kernel. These expressions allow to identify all degenerate cases as well as all G-closed singular vectors. They also lead to the discovery of subsingular vectors for the twisted N=2 superconformal algebra. Explicit examples of these subsingular vectors are given for the levels (1)/(2), 1, and (3)/(2). Finally, the multiplication rules for singular vector operators are derived using the ordering kernel coefficients. This sets the basis for the analysis of the twisted N=2 embedding diagrams. (orig.)

  10. Clifford algebras and the minimal representations of the 1D N-extended supersymmetry algebra

    International Nuclear Information System (INIS)

    Toppan, Francesco

    2008-01-01

    The Atiyah-Bott-Shapiro classification of the irreducible Clifford algebra is used to derive general properties of the minimal representations of the 1D N-Extended Supersymmetry algebra (the Z 2 -graded symmetry algebra of the Supersymmetric Quantum Mechanics) linearly realized on a finite number of fields depending on a real parameter t, the time. (author)

  11. Contraction of graded su(2) algebra

    International Nuclear Information System (INIS)

    Patra, M.K.; Tripathy, K.C.

    1989-01-01

    The Inoenu-Wigner contraction scheme is extended to Lie superalgebras. The structure and representations of extended BRS algebra are obtained from contraction of the graded su(2) algebra. From cohomological consideration, we demonstrate that the graded su(2) algebra is the only superalgebra which, on contraction, yields the full BRS algebra. (orig.)

  12. Atomic effect algebras with compression bases

    International Nuclear Information System (INIS)

    Caragheorgheopol, Dan; Tkadlec, Josef

    2011-01-01

    Compression base effect algebras were recently introduced by Gudder [Demonstr. Math. 39, 43 (2006)]. They generalize sequential effect algebras [Rep. Math. Phys. 49, 87 (2002)] and compressible effect algebras [Rep. Math. Phys. 54, 93 (2004)]. The present paper focuses on atomic compression base effect algebras and the consequences of atoms being foci (so-called projections) of the compressions in the compression base. Part of our work generalizes results obtained in atomic sequential effect algebras by Tkadlec [Int. J. Theor. Phys. 47, 185 (2008)]. The notion of projection-atomicity is introduced and studied, and several conditions that force a compression base effect algebra or the set of its projections to be Boolean are found. Finally, we apply some of these results to sequential effect algebras and strengthen a previously established result concerning a sufficient condition for them to be Boolean.

  13. Operator theory, operator algebras and applications

    CERN Document Server

    Lebre, Amarino; Samko, Stefan; Spitkovsky, Ilya

    2014-01-01

    This book consists of research papers that cover the scientific areas of the International Workshop on Operator Theory, Operator Algebras and Applications, held in Lisbon in September 2012. The volume particularly focuses on (i) operator theory and harmonic analysis (singular integral operators with shifts; pseudodifferential operators, factorization of almost periodic matrix functions; inequalities; Cauchy type integrals; maximal and singular operators on generalized Orlicz-Morrey spaces; the Riesz potential operator; modification of Hadamard fractional integro-differentiation), (ii) operator algebras (invertibility in groupoid C*-algebras; inner endomorphisms of some semi group, crossed products; C*-algebras generated by mappings which have finite orbits; Folner sequences in operator algebras; arithmetic aspect of C*_r SL(2); C*-algebras of singular integral operators; algebras of operator sequences) and (iii) mathematical physics (operator approach to diffraction from polygonal-conical screens; Poisson geo...

  14. A twisted generalization of Novikov-Poisson algebras

    OpenAIRE

    Yau, Donald

    2010-01-01

    Hom-Novikov-Poisson algebras, which are twisted generalizations of Novikov-Poisson algebras, are studied. Hom-Novikov-Poisson algebras are shown to be closed under tensor products and several kinds of twistings. Necessary and sufficient conditions are given under which Hom-Novikov-Poisson algebras give rise to Hom-Poisson algebras.

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

  16. Process Algebra and Markov Chains

    NARCIS (Netherlands)

    Brinksma, Hendrik; Hermanns, H.; Brinksma, Hendrik; Hermanns, H.; Katoen, Joost P.

    This paper surveys and relates the basic concepts of process algebra and the modelling of continuous time Markov chains. It provides basic introductions to both fields, where we also study the Markov chains from an algebraic perspective, viz. that of Markov chain algebra. We then proceed to study

  17. Process algebra and Markov chains

    NARCIS (Netherlands)

    Brinksma, E.; Hermanns, H.; Brinksma, E.; Hermanns, H.; Katoen, J.P.

    2001-01-01

    This paper surveys and relates the basic concepts of process algebra and the modelling of continuous time Markov chains. It provides basic introductions to both fields, where we also study the Markov chains from an algebraic perspective, viz. that of Markov chain algebra. We then proceed to study

  18. Vertex ring-indexed Lie algebras

    International Nuclear Information System (INIS)

    Fairlie, David; Zachos, Cosmas

    2005-01-01

    Infinite-dimensional Lie algebras are introduced, which are only partially graded, and are specified by indices lying on cyclotomic rings. They may be thought of as generalizations of the Onsager algebra, but unlike it, or its sl(n) generalizations, they are not subalgebras of the loop algebras associated with sl(n). In a particular interesting case associated with sl(3), their indices lie on the Eisenstein integer triangular lattice, and these algebras are expected to underlie vertex operator combinations in CFT, brane physics, and graphite monolayers

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

  20. Q-systems as cluster algebras

    International Nuclear Information System (INIS)

    Kedem, Rinat

    2008-01-01

    Q-systems first appeared in the analysis of the Bethe equations for the XXX model and generalized Heisenberg spin chains (Kirillov and Reshetikhin 1987 Zap. Nauchn. Sem. Leningr. Otd. Mat. Inst. Steklov. 160 211-21, 301). Such systems are known to exist for any simple Lie algebra and many other Kac-Moody algebras. We formulate the Q-system associated with any simple, simply-laced Lie algebras g in the language of cluster algebras (Fomin and Zelevinsky 2002 J. Am. Math. Soc. 15 497-529), and discuss the relation of the polynomiality property of the solutions of the Q-system in the initial variables, which follows from the representation-theoretical interpretation, to the Laurent phenomenon in cluster algebras (Fomin and Zelevinsky 2002 Adv. Appl. Math. 28 119-44)

  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. The Cuntz algebra Q_N and C*-algebras of product systems

    DEFF Research Database (Denmark)

    Hong, Jeong Hee; Larsen, Nadia S.; Szymanski, Wojciech

    2011-01-01

    We consider a product system over the multiplicative group semigroup N^x of Hilbert bimodules which is implicit in work of S. Yamashita and of the second named author. We prove directly, using universal properties, that the associated Nica-Toeplitz algebra is an extension of the C*-algebra Q...

  3. Lectures on algebraic quantum field theory and operator algebras

    International Nuclear Information System (INIS)

    Schroer, Bert

    2001-04-01

    In this series of lectures directed towards a mainly mathematically oriented audience I try to motivate the use of operator algebra methods in quantum field theory. Therefore a title as why mathematicians are/should be interested in algebraic quantum field theory would be equally fitting. besides a presentation of the framework and the main results of local quantum physics these notes may serve as a guide to frontier research problems in mathematical. (author)

  4. q-deformations of noncompact Lie (super-) algebras: The examples of q-deformed Lorentz, Weyl, Poincare' and (super-) conformal algebras

    International Nuclear Information System (INIS)

    Dobrev, V.K.

    1992-01-01

    We review and explain a canonical procedure for the q-deformation of the real forms G of complex Lie (super-) algebras associated with (generalized) Cartan matrices. Our procedure gives different q-deformations for the non-conjugate Cartan subalgebras of G. We give several in detail the q-deformed Lorentz and conformal (super-) algebras. The q-deformed conformal algebra contains as a subalgebra a q-deformed Poincare algebra and as Hopf subalgebras two conjugate 11-generator q-deformed Weyl algebras. The q-deformed Lorentz algebra in Hopf subalgebra of both Weyl algebras. (author). 24 refs

  5. Assessing Algebraic Solving Ability: A Theoretical Framework

    Science.gov (United States)

    Lian, Lim Hooi; Yew, Wun Thiam

    2012-01-01

    Algebraic solving ability had been discussed by many educators and researchers. There exists no definite definition for algebraic solving ability as it can be viewed from different perspectives. In this paper, the nature of algebraic solving ability in terms of algebraic processes that demonstrate the ability in solving algebraic problem is…

  6. Associative and Lie deformations of Poisson algebras

    OpenAIRE

    Remm, Elisabeth

    2011-01-01

    Considering a Poisson algebra as a non associative algebra satisfying the Markl-Remm identity, we study deformations of Poisson algebras as deformations of this non associative algebra. This gives a natural interpretation of deformations which preserves the underlying associative structure and we study deformations which preserve the underlying Lie algebra.

  7. Paragrassmann analysis and covariant quantum algebras

    International Nuclear Information System (INIS)

    Filippov, A.T.; Isaev, A.P.; Kurdikov, A.B.; Pyatov, P.N.

    1993-01-01

    This report is devoted to the consideration from the algebraic point of view the paragrassmann algebras with one and many paragrassmann generators Θ i , Θ p+1 i = 0. We construct the paragrassmann versions of the Heisenberg algebra. For the special case, this algebra is nothing but the algebra for coordinates and derivatives considered in the context of covariant differential calculus on quantum hyperplane. The parameter of deformation q in our case is (p+1)-root of unity. Our construction is nondegenerate only for even p. Taking bilinear combinations of paragrassmann derivatives and coordinates we realize generators for the covariant quantum algebras as tensor products of (p+1) x (p+1) matrices. (orig./HSI)

  8. CLASSIFICATION OF 4-DIMENSIONAL GRADED ALGEBRAS

    OpenAIRE

    Armour, Aaron; Chen, Hui-Xiang; ZHANG, Yinhuo

    2009-01-01

    Let k be an algebraically closed field. The algebraic and geometric classification of finite dimensional algebras over k with ch(k) not equal 2 was initiated by Gabriel in [6], where a complete list of nonisomorphic 4-dimensional k-algebras was given and the number of irreducible components of the variety Alg(4) was discovered to be 5. The classification of 5-dimensional k-algebras was done by Mazzola in [10]. The number of irreducible components of the variety Alg(5) is 10. With the dimensio...

  9. Banana Algebra: Compositional syntactic language extension

    DEFF Research Database (Denmark)

    Andersen, Jacob; Brabrand, Claus; Christiansen, David Raymond

    2013-01-01

    We propose an algebra of languages and transformations as a means of compositional syntactic language extension. The algebra provides a layer of high-level abstractions built on top of languages (captured by context-free grammars) and transformations (captured by constructive catamorphisms...... algebra as presented in the paper is implemented as the Banana Algebra Tool which may be used to syntactically extend languages in an incremental and modular fashion via algebraic composition of previously defined languages and transformations. We demonstrate and evaluate the tool via several kinds...

  10. Linear algebra

    CERN Document Server

    Liesen, Jörg

    2015-01-01

    This self-contained textbook takes a matrix-oriented approach to linear algebra and presents a complete theory, including all details and proofs, culminating in the Jordan canonical form and its proof. Throughout the development, the applicability of the results is highlighted. Additionally, the book presents special topics from applied linear algebra including matrix functions, the singular value decomposition, the Kronecker product and linear matrix equations. The matrix-oriented approach to linear algebra leads to a better intuition and a deeper understanding of the abstract concepts, and therefore simplifies their use in real world applications. Some of these applications are presented in detailed examples. In several ‘MATLAB-Minutes’ students can comprehend the concepts and results using computational experiments. Necessary basics for the use of MATLAB are presented in a short introduction. Students can also actively work with the material and practice their mathematical skills in more than 300 exerc...

  11. JB*-Algebras of Topological Stable Rank 1

    Directory of Open Access Journals (Sweden)

    Akhlaq A. Siddiqui

    2007-01-01

    Full Text Available In 1976, Kaplansky introduced the class JB*-algebras which includes all C*-algebras as a proper subclass. The notion of topological stable rank 1 for C*-algebras was originally introduced by M. A. Rieffel and was extensively studied by various authors. In this paper, we extend this notion to general JB*-algebras. We show that the complex spin factors are of tsr 1 providing an example of special JBW*-algebras for which the enveloping von Neumann algebras may not be of tsr 1. In the sequel, we prove that every invertible element of a JB*-algebra is positive in certain isotope of ; if the algebra is finite-dimensional, then it is of tsr 1 and every element of is positive in some unitary isotope of . Further, it is established that extreme points of the unit ball sufficiently close to invertible elements in a JB*-algebra must be unitaries and that in any JB*-algebras of tsr 1, all extreme points of the unit ball are unitaries. In the end, we prove the coincidence between the λ-function and λu-function on invertibles in a JB*-algebra.

  12. (Super)conformal algebra on the (super)torus

    International Nuclear Information System (INIS)

    Mezincescu, L.; Nepomechie, R.I.; Zachos, C.K.

    1989-01-01

    A generalization of the Virasoro algebra has recently been introduced by Krichever and Novikov (KN). The KN algebra describes the algebra of general conformal transformations in a basis appropriate to a genus-g Riemann surface. We examine in detail the genus-one KN algebra, and find explicit expressions for the central extension. We, further, construct explicitly the superconformal algebra of the supertorus, which yields supersymmetric generalizations of the genus-one KN algebra. A novel feature of the odd-spin-structure case is that the algebra includes a central element which is anticommuting. We comment on possible applications to string theory. (orig.)

  13. Spin-4 extended conformal algebras

    International Nuclear Information System (INIS)

    Kakas, A.C.

    1988-01-01

    We construct spin-4 extended conformal algebras using the second hamiltonian structure of the KdV hierarchy. In the presence of a U(1) current a family of spin-4 algebras exists but the additional requirement that the spin-1 and spin-4 currents commute fixes the algebra uniquely. (orig.)

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

  15. Nonlinear evolution equations and solving algebraic systems: the importance of computer algebra

    International Nuclear Information System (INIS)

    Gerdt, V.P.; Kostov, N.A.

    1989-01-01

    In the present paper we study the application of computer algebra to solve the nonlinear polynomial systems which arise in investigation of nonlinear evolution equations. We consider several systems which are obtained in classification of integrable nonlinear evolution equations with uniform rank. Other polynomial systems are related with the finding of algebraic curves for finite-gap elliptic potentials of Lame type and generalizations. All systems under consideration are solved using the method based on construction of the Groebner basis for corresponding polynomial ideals. The computations have been carried out using computer algebra systems. 20 refs

  16. Rudiments of algebraic geometry

    CERN Document Server

    Jenner, WE

    2017-01-01

    Aimed at advanced undergraduate students of mathematics, this concise text covers the basics of algebraic geometry. Topics include affine spaces, projective spaces, rational curves, algebraic sets with group structure, more. 1963 edition.

  17. Applications of Computer Algebra Conference

    CERN Document Server

    Martínez-Moro, Edgar

    2017-01-01

    The Applications of Computer Algebra (ACA) conference covers a wide range of topics from Coding Theory to Differential Algebra to Quantam Computing, focusing on the interactions of these and other areas with the discipline of Computer Algebra. This volume provides the latest developments in the field as well as its applications in various domains, including communications, modelling, and theoretical physics. The book will appeal to researchers and professors of computer algebra, applied mathematics, and computer science, as well as to engineers and computer scientists engaged in research and development.

  18. Chiral algebras of class S

    CERN Document Server

    Beem, Christopher; Rastelli, Leonardo; van Rees, Balt C.

    2015-01-01

    Four-dimensional N=2 superconformal field theories have families of protected correlation functions that possess the structure of two-dimensional chiral algebras. In this paper, we explore the chiral algebras that arise in this manner in the context of theories of class S. The class S duality web implies nontrivial associativity properties for the corresponding chiral algebras, the structure of which is best summarized in the language of generalized topological quantum field theory. We make a number of conjectures regarding the chiral algebras associated to various strongly coupled fixed points.

  19. Homotopy Theory of C*-Algebras

    CERN Document Server

    Ostvaer, Paul Arne

    2010-01-01

    Homotopy theory and C* algebras are central topics in contemporary mathematics. This book introduces a modern homotopy theory for C*-algebras. One basic idea of the setup is to merge C*-algebras and spaces studied in algebraic topology into one category comprising C*-spaces. These objects are suitable fodder for standard homotopy theoretic moves, leading to unstable and stable model structures. With the foundations in place one is led to natural definitions of invariants for C*-spaces such as homology and cohomology theories, K-theory and zeta-functions. The text is largely self-contained. It

  20. Computational aspects of algebraic curves

    CERN Document Server

    Shaska, Tanush

    2005-01-01

    The development of new computational techniques and better computing power has made it possible to attack some classical problems of algebraic geometry. The main goal of this book is to highlight such computational techniques related to algebraic curves. The area of research in algebraic curves is receiving more interest not only from the mathematics community, but also from engineers and computer scientists, because of the importance of algebraic curves in applications including cryptography, coding theory, error-correcting codes, digital imaging, computer vision, and many more.This book cove

  1. The algebras of large N matrix mechanics

    Energy Technology Data Exchange (ETDEWEB)

    Halpern, M.B.; Schwartz, C.

    1999-09-16

    Extending early work, we formulate the large N matrix mechanics of general bosonic, fermionic and supersymmetric matrix models, including Matrix theory: The Hamiltonian framework of large N matrix mechanics provides a natural setting in which to study the algebras of the large N limit, including (reduced) Lie algebras, (reduced) supersymmetry algebras and free algebras. We find in particular a broad array of new free algebras which we call symmetric Cuntz algebras, interacting symmetric Cuntz algebras, symmetric Bose/Fermi/Cuntz algebras and symmetric Cuntz superalgebras, and we discuss the role of these algebras in solving the large N theory. Most important, the interacting Cuntz algebras are associated to a set of new (hidden!) local quantities which are generically conserved only at large N. A number of other new large N phenomena are also observed, including the intrinsic nonlocality of the (reduced) trace class operators of the theory and a closely related large N field identification phenomenon which is associated to another set (this time nonlocal) of new conserved quantities at large N.

  2. (L,M-Fuzzy σ-Algebras

    Directory of Open Access Journals (Sweden)

    Fu-Gui Shi

    2010-01-01

    Full Text Available The notion of (L,M-fuzzy σ-algebras is introduced in the lattice value fuzzy set theory. It is a generalization of Klement's fuzzy σ-algebras. In our definition of (L,M-fuzzy σ-algebras, each L-fuzzy subset can be regarded as an L-measurable set to some degree.

  3. Explicit field realizations of W algebras

    OpenAIRE

    Wei, Shao-Wen; Liu, Yu-Xiao; Zhang, Li-Jie; Ren, Ji-Rong

    2009-01-01

    The fact that certain non-linear $W_{2,s}$ algebras can be linearized by the inclusion of a spin-1 current can provide a simple way to realize $W_{2,s}$ algebras from linear $W_{1,2,s}$ algebras. In this paper, we first construct the explicit field realizations of linear $W_{1,2,s}$ algebras with double-scalar and double-spinor, respectively. Then, after a change of basis, the realizations of $W_{2,s}$ algebras are presented. The results show that all these realizations are Romans-type realiz...

  4. Explicit field realizations of W algebras

    International Nuclear Information System (INIS)

    Wei Shaowen; Liu Yuxiao; Ren Jirong; Zhang Lijie

    2009-01-01

    The fact that certain nonlinear W 2,s algebras can be linearized by the inclusion of a spin-1 current can provide a simple way to realize W 2,s algebras from linear W 1,2,s algebras. In this paper, we first construct the explicit field realizations of linear W 1,2,s algebras with double scalar and double spinor, respectively. Then, after a change of basis, the realizations of W 2,s algebras are presented. The results show that all these realizations are Romans-type realizations.

  5. Hurwitz Algebras and the Octonion Algebra

    Science.gov (United States)

    Burdik, Čestmir; Catto, Sultan

    2018-02-01

    We explore some consequences of a theory of internal symmetries for elementary particles constructed on exceptional quantum mechanical spaces based on Jordan algebra formulation that admit exceptional groups as gauge groups.

  6. On d -Dimensional Lattice (co)sine n -Algebra

    International Nuclear Information System (INIS)

    Yao Shao-Kui; Zhang Chun-Hong; Zhao Wei-Zhong; Ding Lu; Liu Peng

    2016-01-01

    We present the (co)sine n-algebra which is indexed by the d-dimensional integer lattice. Due to the associative operators, this generalized (co)sine n-algebra is the higher order Lie algebra for the n even case. The particular cases are the d-dimensional lattice sine 3 and cosine 5-algebras with the special parameter values. We find that the corresponding d-dimensional lattice sine 3 and cosine 5-algebras are the Nambu 3-algebra and higher order Lie algebra, respectively. The limiting case of the d-dimensional lattice (co)sine n-algebra is also discussed. Moreover we construct the super sine n-algebra, which is the super higher order Lie algebra for the n even case. (paper)

  7. Pre-Algebra Lexicon.

    Science.gov (United States)

    Hayden, Dunstan; Cuevas, Gilberto

    The pre-algebra lexicon is a set of classroom exercises designed to teach the technical words and phrases of pre-algebra mathematics, and includes the terms most commonly found in related mathematics courses. The lexicon has three parts, each with its own introduction. The first introduces vocabulary items in three groups forming a learning…

  8. An Arithmetic-Algebraic Work Space for the Promotion of Arithmetic and Algebraic Thinking: Triangular Numbers

    Science.gov (United States)

    Hitt, Fernando; Saboya, Mireille; Cortés Zavala, Carlos

    2016-01-01

    This paper presents an experiment that attempts to mobilise an arithmetic-algebraic way of thinking in order to articulate between arithmetic thinking and the early algebraic thinking, which is considered a prelude to algebraic thinking. In the process of building this latter way of thinking, researchers analysed pupils' spontaneous production…

  9. n-ary algebras: a review with applications

    International Nuclear Information System (INIS)

    De Azcarraga, J A; Izquierdo, J M

    2010-01-01

    This paper reviews the properties and applications of certain n-ary generalizations of Lie algebras in a self-contained and unified way. These generalizations are algebraic structures in which the two-entry Lie bracket has been replaced by a bracket with n entries. Each type of n-ary bracket satisfies a specific characteristic identity which plays the role of the Jacobi identity for Lie algebras. Particular attention will be paid to generalized Lie algebras, which are defined by even multibrackets obtained by antisymmetrizing the associative products of its n components and that satisfy the generalized Jacobi identity, and to Filippov (or n-Lie) algebras, which are defined by fully antisymmetric n-brackets that satisfy the Filippov identity. 3-Lie algebras have surfaced recently in multi-brane theory in the context of the Bagger-Lambert-Gustavsson model. As a result, Filippov algebras will be discussed at length, including the cohomology complexes that govern their central extensions and their deformations (it turns out that Whitehead's lemma extends to all semisimple n-Lie algebras). When the skewsymmetry of the Lie or n-Lie algebra bracket is relaxed, one is led to a more general type of n-algebras, the n-Leibniz algebras. These will be discussed as well, since they underlie the cohomological properties of n-Lie algebras. The standard Poisson structure may also be extended to the n-ary case. We shall review here the even generalized Poisson structures, whose generalized Jacobi identity reproduces the pattern of the generalized Lie algebras, and the Nambu-Poisson structures, which satisfy the Filippov identity and determine Filippov algebras. Finally, the recent work of Bagger-Lambert and Gustavsson on superconformal Chern-Simons theory will be briefly discussed. Emphasis will be made on the appearance of the 3-Lie algebra structure and on why the A 4 model may be formulated in terms of an ordinary Lie algebra, and on its Nambu bracket generalization. (topical

  10. Additive derivations on algebras of measurable operators

    International Nuclear Information System (INIS)

    Ayupov, Sh.A.; Kudaybergenov, K.K.

    2009-08-01

    Given a von Neumann algebra M we introduce the so-called central extension mix(M) of M. We show that mix(M) is a *-subalgebra in the algebra LS(M) of all locally measurable operators with respect to M, and this algebra coincides with LS(M) if and only if M does not admit type II direct summands. We prove that if M is a properly infinite von Neumann algebra then every additive derivation on the algebra mix(M) is inner. This implies that on the algebra LS(M), where M is a type I ∞ or a type III von Neumann algebra, all additive derivations are inner derivations. (author)

  11. Families talen en algebra

    NARCIS (Netherlands)

    Asveld, P.R.J.

    1976-01-01

    Operaties op formele talen geven aanleiding tot bijbehorende operatoren op families talen. Bepaalde onderwerpen uit de algebra (universele algebra, tralies, partieel geordende monoiden) kunnen behulpzaam zijn in de studie van verzamelingen van dergelijke operatoren.

  12. Ternary q-Virasoro-Witt Hom-Nambu-Lie algebras

    International Nuclear Information System (INIS)

    Ammar, F; Makhlouf, A; Silvestrov, S

    2010-01-01

    In this paper we construct ternary q-Virasoro-Witt algebras which q-deform the ternary Virasoro-Witt algebras constructed by Curtright, Fairlie and Zachos using su(1, 1) enveloping algebra techniques. The ternary Virasoro-Witt algebras constructed by Curtright, Fairlie and Zachos depend on a parameter and are not Nambu-Lie algebras for all but finitely many values of this parameter. For the parameter values for which the ternary Virasoro-Witt algebras are Nambu-Lie, the corresponding ternary q-Virasoro-Witt algebras constructed in this paper are also Hom-Nambu-Lie because they are obtained from the ternary Nambu-Lie algebras using the composition method. For other parameter values this composition method does not yield a Hom-Nambu-Lie algebra structure for q-Virasoro-Witt algebras. We show however, using a different construction, that the ternary Virasoro-Witt algebras of Curtright, Fairlie and Zachos, as well as the general ternary q-Virasoro-Witt algebras we construct, carry a structure of the ternary Hom-Nambu-Lie algebra for all values of the involved parameters.

  13. Algebraic Methods to Design Signals

    Science.gov (United States)

    2015-08-27

    to date on designing signals using algebraic and combinatorial methods. Mathematical tools from algebraic number theory, representation theory and... combinatorial objects in designing signals for communication purposes. Sequences and arrays with desirable autocorrelation properties have many...multiple access methods in mobile radio communication systems. We continue our mathematical framework based on group algebras, character theory

  14. Assessing Elementary Algebra with STACK

    Science.gov (United States)

    Sangwin, Christopher J.

    2007-01-01

    This paper concerns computer aided assessment (CAA) of mathematics in which a computer algebra system (CAS) is used to help assess students' responses to elementary algebra questions. Using a methodology of documentary analysis, we examine what is taught in elementary algebra. The STACK CAA system, http://www.stack.bham.ac.uk/, which uses the CAS…

  15. Homological methods, representation theory, and cluster algebras

    CERN Document Server

    Trepode, Sonia

    2018-01-01

    This text presents six mini-courses, all devoted to interactions between representation theory of algebras, homological algebra, and the new ever-expanding theory of cluster algebras. The interplay between the topics discussed in this text will continue to grow and this collection of courses stands as a partial testimony to this new development. The courses are useful for any mathematician who would like to learn more about this rapidly developing field; the primary aim is to engage graduate students and young researchers. Prerequisites include knowledge of some noncommutative algebra or homological algebra. Homological algebra has always been considered as one of the main tools in the study of finite-dimensional algebras. The strong relationship with cluster algebras is more recent and has quickly established itself as one of the important highlights of today’s mathematical landscape. This connection has been fruitful to both areas—representation theory provides a categorification of cluster algebras, wh...

  16. From simplicial Lie algebras and hypercrossed complexes to differential graded Lie algebras via 1-jets

    OpenAIRE

    Jurco, Branislav

    2011-01-01

    Let g be a simplicial Lie algebra with Moore complex Ng of length k. Let G be the simplicial Lie group integrating g, which is simply connected in each simplicial level. We use the 1-jet of the classifying space of G to construct, starting from g, a Lie k-algebra L. The so constructed Lie k-algebra L is actually a differential graded Lie algebra. The differential and the brackets are explicitly described in terms (of a part) of the corresponding k-hypercrossed complex structure of Ng. The res...

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

  18. Sugawara operators for classical Lie algebras

    CERN Document Server

    Molev, Alexander

    2018-01-01

    The celebrated Schur-Weyl duality gives rise to effective ways of constructing invariant polynomials on the classical Lie algebras. The emergence of the theory of quantum groups in the 1980s brought up special matrix techniques which allowed one to extend these constructions beyond polynomial invariants and produce new families of Casimir elements for finite-dimensional Lie algebras. Sugawara operators are analogs of Casimir elements for the affine Kac-Moody algebras. The goal of this book is to describe algebraic structures associated with the affine Lie algebras, including affine vertex algebras, Yangians, and classical \\mathcal{W}-algebras, which have numerous ties with many areas of mathematics and mathematical physics, including modular forms, conformal field theory, and soliton equations. An affine version of the matrix technique is developed and used to explain the elegant constructions of Sugawara operators, which appeared in the last decade. An affine analogue of the Harish-Chandra isomorphism connec...

  19. Algebraic Systems and Pushdown Automata

    Science.gov (United States)

    Petre, Ion; Salomaa, Arto

    We concentrate in this chapter on the core aspects of algebraic series, pushdown automata, and their relation to formal languages. We choose to follow here a presentation of their theory based on the concept of properness. We introduce in Sect. 2 some auxiliary notions and results needed throughout the chapter, in particular the notions of discrete convergence in semirings and C-cycle free infinite matrices. In Sect. 3 we introduce the algebraic power series in terms of algebraic systems of equations. We focus on interconnections with context-free grammars and on normal forms. We then conclude the section with a presentation of the theorems of Shamir and Chomsky-Schützenberger. We discuss in Sect. 4 the algebraic and the regulated rational transductions, as well as some representation results related to them. Section 5 is dedicated to pushdown automata and focuses on the interconnections with classical (non-weighted) pushdown automata and on the interconnections with algebraic systems. We then conclude the chapter with a brief discussion of some of the other topics related to algebraic systems and pushdown automata.

  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. Ready, Set, Algebra?

    Science.gov (United States)

    Levy, Alissa Beth

    2012-01-01

    The California Department of Education (CDE) has long asserted that success Algebra I by Grade 8 is the goal for all California public school students. In fact, the state's accountability system penalizes schools that do not require all of their students to take the Algebra I end-of-course examination by Grade 8 (CDE, 2009). In this dissertation,…

  2. Block diagonalization for algebra's associated with block codes

    NARCIS (Netherlands)

    D. Gijswijt (Dion)

    2009-01-01

    htmlabstractFor a matrix *-algebra B, consider the matrix *-algebra A consisting of the symmetric tensors in the n-fold tensor product of B. Examples of such algebras in coding theory include the Bose-Mesner algebra and Terwilliger algebra of the (non)binary Hamming cube, and algebras arising in

  3. Grassmann, super-Kac-Moody and super-derivation algebras

    International Nuclear Information System (INIS)

    Frappat, L.; Ragoucy, E.; Sorba, P.

    1989-05-01

    We study the cyclic cocycles of degree one on the Grassmann algebra and on the super-circle with N supersymmetries (i.e. the tensor product of the algebra of functions on the circle times a Grassmann algebra with N generators). They are related to central extensions of graded loop algebras (i.e. super-Kac-Moody algebras). The corresponding algebras of super-derivations have to be compatible with the cocycle characterizing the extension; we give a general method for determining these algebras and examine in particular the cases N = 1,2,3. We also discuss their relations with the Ademollo et al. algebras, and examine the possibility of defining new kinds of super-conformal algebras, which, for N > 1, generalize the N = 1 Ramond-Neveu-Schwarz algebra

  4. Current algebra

    International Nuclear Information System (INIS)

    Jacob, M.

    1967-01-01

    The first three chapters of these lecture notes are devoted to generalities concerning current algebra. The weak currents are defined, and their main properties given (V-A hypothesis, conserved vector current, selection rules, partially conserved axial current,...). The SU (3) x SU (3) algebra of Gell-Mann is introduced, and the general properties of the non-leptonic weak Hamiltonian are discussed. Chapters 4 to 9 are devoted to some important applications of the algebra. First one proves the Adler- Weisberger formula, in two different ways, by either the infinite momentum frame, or the near-by singularities method. In the others chapters, the latter method is the only one used. The following topics are successively dealt with: semi leptonic decays of K mesons and hyperons, Kroll- Ruderman theorem, non leptonic decays of K mesons and hyperons ( ΔI = 1/2 rule), low energy theorems concerning processes with emission (or absorption) of a pion or a photon, super-convergence sum rules, and finally, neutrino reactions. (author) [fr

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

  6. A type of loop algebra and the associated loop algebras

    International Nuclear Information System (INIS)

    Tam Honwah; Zhang Yufeng

    2008-01-01

    A higher-dimensional twisted loop algebra is constructed. As its application, a new Lax pair is presented, whose compatibility gives rise to a Liouville integrable hierarchy of evolution equations by making use of Tu scheme. One of the reduction cases of the hierarchy is an analogous of the well-known AKNS system. Next, the twisted loop algebra, furthermore, is extended to another higher dimensional loop algebra, from which a hierarchy of evolution equations with 11-potential component functions is obtained, whose reduction is just standard AKNS system. Especially, we prove that an arbitrary linear combination of the four Hamiltonian operators directly obtained from the recurrence relations is still a Hamiltonian operator. Therefore, the hierarchy with 11-potential functions possesses 4-Hamiltonian structures. Finally, an integrable coupling of the hierarchy is worked out

  7. Spin-zero mesons and current algebras

    International Nuclear Information System (INIS)

    Wellner, M.

    1977-01-01

    Large chiral algebras, using the f and d coefficients of SU(3) can be constructed with spin-1/2 baryons. Such algebras have been found useful in some previous investigations. This article examines under what conditions similar or identical current algebras may be realized with spin-0 mesons. A curious lack of analogy emerges between meson and baryon currents. Second-class currents, made of mesons, are required in some algebras. If meson and baryon currents are to satisfy the same extended SU(3) algebra, four meson nonets are needed, in terms of which we give an explicit construction for the currents

  8. Chiral algebras for trinion theories

    International Nuclear Information System (INIS)

    Lemos, Madalena; Peelaers, Wolfger

    2015-01-01

    It was recently understood that one can identify a chiral algebra in any four-dimensional N=2 superconformal theory. In this note, we conjecture the full set of generators of the chiral algebras associated with the T n theories. The conjecture is motivated by making manifest the critical affine module structure in the graded partition function of the chiral algebras, which is computed by the Schur limit of the superconformal index for T n theories. We also explicitly construct the chiral algebra arising from the T 4 theory. Its null relations give rise to new T 4 Higgs branch chiral ring relations.

  9. Fast multigrid-based computation of the induced electric field for transcranial magnetic stimulation

    Science.gov (United States)

    Laakso, Ilkka; Hirata, Akimasa

    2012-12-01

    In transcranial magnetic stimulation (TMS), the distribution of the induced electric field, and the affected brain areas, depends on the position of the stimulation coil and the individual geometry of the head and brain. The distribution of the induced electric field in realistic anatomies can be modelled using computational methods. However, existing computational methods for accurately determining the induced electric field in realistic anatomical models have suffered from long computation times, typically in the range of tens of minutes or longer. This paper presents a matrix-free implementation of the finite-element method with a geometric multigrid method that can potentially reduce the computation time to several seconds or less even when using an ordinary computer. The performance of the method is studied by computing the induced electric field in two anatomically realistic models. An idealized two-loop coil is used as the stimulating coil. Multiple computational grid resolutions ranging from 2 to 0.25 mm are used. The results show that, for macroscopic modelling of the electric field in an anatomically realistic model, computational grid resolutions of 1 mm or 2 mm appear to provide good numerical accuracy compared to higher resolutions. The multigrid iteration typically converges in less than ten iterations independent of the grid resolution. Even without parallelization, each iteration takes about 1.0 s or 0.1 s for the 1 and 2 mm resolutions, respectively. This suggests that calculating the electric field with sufficient accuracy in real time is feasible.

  10. The $W_{3}$ algebra modules, semi-infinite cohomology and BV algebras

    CERN Document Server

    Bouwknegt, Peter; Pilch, Krzysztof

    1996-01-01

    The noncritical D=4 W_3 string is a model of W_3 gravity coupled to two free scalar fields. In this paper we discuss its BRST quantization in direct analogy with that of the D=2 (Virasoro) string. In particular, we calculate the physical spectrum as a problem in BRST cohomology. The corresponding operator cohomology forms a BV-algebra. We model this BV-algebra on that of the polyderivations of a commutative ring on six variables with a quadratic constraint, or equivalently, on the BV-algebra of (polynomial) polyvector fields on the base affine space of SL(3,C). In this paper we attempt to present a complete summary of the progress made in these studies. [...

  11. Normed algebras and the geometric series test

    Directory of Open Access Journals (Sweden)

    Robert Kantrowitz

    2017-11-01

    Full Text Available The purpose of this article is to survey a class of normed algebras that share many central features of Banach algebras, save for completeness. The likeness of these algebras to Banach algebras derives from the fact that the geometric series test is valid, whereas the lack of completeness points to the failure of the absolute convergence test for series in the algebra. Our main result is a compendium of conditions that are all equivalent to the validity of the geometric series test for commutative unital normed algebras. Several examples in the final section showcase some incomplete normed algebras for which the geometric series test is valid, and still others for which it is not.

  12. Representations of affine Hecke algebras

    CERN Document Server

    Xi, Nanhua

    1994-01-01

    Kazhdan and Lusztig classified the simple modules of an affine Hecke algebra Hq (q E C*) provided that q is not a root of 1 (Invent. Math. 1987). Ginzburg had some very interesting work on affine Hecke algebras. Combining these results simple Hq-modules can be classified provided that the order of q is not too small. These Lecture Notes of N. Xi show that the classification of simple Hq-modules is essentially different from general cases when q is a root of 1 of certain orders. In addition the based rings of affine Weyl groups are shown to be of interest in understanding irreducible representations of affine Hecke algebras. Basic knowledge of abstract algebra is enough to read one third of the book. Some knowledge of K-theory, algebraic group, and Kazhdan-Lusztig cell of Cexeter group is useful for the rest

  13. A modal characterization of Peirce algebras

    NARCIS (Netherlands)

    M. de Rijke (Maarten)

    1995-01-01

    textabstractPeirce algebras combine sets, relations and various operations linking the two in a unifying setting.This note offers a modal perspective on Peirce algebras.It uses modal logic to characterize the full Peirce algebras.

  14. On δ-derivations of n-ary algebras

    International Nuclear Information System (INIS)

    Kaygorodov, Ivan B

    2012-01-01

    We give a description of δ-derivations of (n+1)-dimensional n-ary Filippov algebras and, as a consequence, of simple finite-dimensional Filippov algebras over an algebraically closed field of characteristic zero. We also give new examples of non-trivial δ-derivations of Filippov algebras and show that there are no non-trivial δ-derivations of the simple ternary Mal'tsev algebra M 8 .

  15. Cluster algebras in mathematical physics

    International Nuclear Information System (INIS)

    Francesco, Philippe Di; Gekhtman, Michael; Kuniba, Atsuo; Yamazaki, Masahito

    2014-01-01

    This special issue of Journal of Physics A: Mathematical and Theoretical contains reviews and original research articles on cluster algebras and their applications to mathematical physics. Cluster algebras were introduced by S Fomin and A Zelevinsky around 2000 as a tool for studying total positivity and dual canonical bases in Lie theory. Since then the theory has found diverse applications in mathematics and mathematical physics. Cluster algebras are axiomatically defined commutative rings equipped with a distinguished set of generators (cluster variables) subdivided into overlapping subsets (clusters) of the same cardinality subject to certain polynomial relations. A cluster algebra of rank n can be viewed as a subring of the field of rational functions in n variables. Rather than being presented, at the outset, by a complete set of generators and relations, it is constructed from the initial seed via an iterative procedure called mutation producing new seeds successively to generate the whole algebra. A seed consists of an n-tuple of rational functions called cluster variables and an exchange matrix controlling the mutation. Relations of cluster algebra type can be observed in many areas of mathematics (Plücker and Ptolemy relations, Stokes curves and wall-crossing phenomena, Feynman integrals, Somos sequences and Hirota equations to name just a few examples). The cluster variables enjoy a remarkable combinatorial pattern; in particular, they exhibit the Laurent phenomenon: they are expressed as Laurent polynomials rather than more general rational functions in terms of the cluster variables in any seed. These characteristic features are often referred to as the cluster algebra structure. In the last decade, it became apparent that cluster structures are ubiquitous in mathematical physics. Examples include supersymmetric gauge theories, Poisson geometry, integrable systems, statistical mechanics, fusion products in infinite dimensional algebras, dilogarithm

  16. The central extensions of Kac-Moody-Malcev algebras

    International Nuclear Information System (INIS)

    Osipov, E.P.

    1989-01-01

    The authors introduce a class of infinite-dimensional Kac-Moody-Malcev algebras. The Kac-Moody-Malcev algebras are the generalization of Lie algebras of Kac-Moody type to the Malcev algebras. They demonstrate that the central extensions of Kac-Moody-Malcev algebras are given by the same cocycles as in the case of Lie algebras. It is given a construction of Virasoro algebra in terms of bilinear combinations of currents satisfying the Kac-Moody-Malcev commutation relations. Thus, it is given the generalization of the Sugawara Construction to the case of Kac-Moody-Malcev algebras. Analogues of Kac-Moody-Malcev algebras may be also introduced in the case of arbitrary Riemann surface

  17. Using Max-Plus Algebra for the Evaluation of Stochastic Process Algebra Prefixes

    NARCIS (Netherlands)

    Cloth, L.; de Alfaro, L.; Gilmore, S.; Bohnenkamp, H.C.; Haverkort, Boudewijn R.H.M.

    2001-01-01

    In this paper, the concept of complete finite prefixes for process algebra expressions is extended to stochastic models. Events are supposed to happen after a delay that is determined by random variables assigned to the preceding conditions. Max-plus algebra expressions are shown to provide an

  18. The structure of relation algebras generated by relativizations

    CERN Document Server

    Givant, Steven R

    1994-01-01

    The foundation for an algebraic theory of binary relations was laid by De Morgan, Peirce, and Schröder during the second half of the nineteenth century. Modern development of the subject as a theory of abstract algebras, called "relation algebras", was undertaken by Tarski and his students. This book aims to analyze the structure of relation algebras that are generated by relativized subalgebras. As examples of their potential for applications, the main results are used to establish representation theorems for classes of relation algebras and to prove existence and uniqueness theorems for simple closures (i.e., for minimal simple algebras containing a given family of relation algebras as relativized subalgebras). This book is well written and accessible to those who are not specialists in this area. In particular, it contains two introductory chapters on the arithmetic and the algebraic theory of relation algebras. This book is suitable for use in graduate courses on algebras of binary relations or algebraic...

  19. Linear-Algebra Programs

    Science.gov (United States)

    Lawson, C. L.; Krogh, F. T.; Gold, S. S.; Kincaid, D. R.; Sullivan, J.; Williams, E.; Hanson, R. J.; Haskell, K.; Dongarra, J.; Moler, C. B.

    1982-01-01

    The Basic Linear Algebra Subprograms (BLAS) library is a collection of 38 FORTRAN-callable routines for performing basic operations of numerical linear algebra. BLAS library is portable and efficient source of basic operations for designers of programs involving linear algebriac computations. BLAS library is supplied in portable FORTRAN and Assembler code versions for IBM 370, UNIVAC 1100 and CDC 6000 series computers.

  20. Quantum double actions on operator algebras and orbifold quantum field theories

    International Nuclear Information System (INIS)

    Mueger, M.

    1996-06-01

    Starting from a local quantum field theory with an unbroken compact symmetry group G in 1+1 dimensional spacetime we construct disorder fields implementing gauge transformations on the fields (order variables) localized in a wedge region. Enlarging the local algebras by these disorder fields we obtain a nonlocal field theory, the fixpoint algebras of which under the appropriately extended action of the group G are shown to satisfy Haag duality in every simple sector. The specifically 1+1 dimensional phenomenon of violation of Haag duality of fixpoint nets is thereby clarified. In the case of a finite group G the extended theory is acted upon in a completely canonical way by the quantum double D(G) and satisfies R-matrix commutation relations as well as a Verlinde algebra. Furthermore, our methods are suitable for a concise and transparent approach to bosonization. The main technical ingredient is a strengthened version of the split property which should hold in all reasonable massive theories. In the appendices (part of) the results are extended to arbitary locally compact groups and our methods are adapted to chiral theories on the circle. (orig.)

  1. P-commutative topological *-algebras

    International Nuclear Information System (INIS)

    Mohammad, N.; Thaheem, A.B.

    1991-07-01

    If P(A) denotes the set of all continuous positive functionals on a unital complete Imc *-algebra and S(A) the extreme points of P(A), and if the spectrum of an element χ Ε A coincides with the set {f(χ): f Ε S(A)}, then A is shown to be P-commutative. Moreover, if A is unital symmetric Frechet Q Imc *-algebra, then this spectral condition is, in fact, necessary. Also, an isomorphism theorem between symmetric Frechet P-commutative Imc *-algebras is established. (author). 12 refs

  2. Matrices and linear algebra

    CERN Document Server

    Schneider, Hans

    1989-01-01

    Linear algebra is one of the central disciplines in mathematics. A student of pure mathematics must know linear algebra if he is to continue with modern algebra or functional analysis. Much of the mathematics now taught to engineers and physicists requires it.This well-known and highly regarded text makes the subject accessible to undergraduates with little mathematical experience. Written mainly for students in physics, engineering, economics, and other fields outside mathematics, the book gives the theory of matrices and applications to systems of linear equations, as well as many related t

  3. Generalized NLS hierarchies from rational W algebras

    International Nuclear Information System (INIS)

    Toppan, F.

    1993-11-01

    Finite rational W algebras are very natural structures appearing in coset constructions when a Kac-Moody subalgebra is factored out. The problem of relating these algebras to integrable hierarchies of equations is studied by showing how to associate to a rational W algebra its corresponding hierarchy. Two examples are worked out, the sl(2)/U(1) coset, leading to the Non-Linear Schroedinger hierarchy, and the U(1) coset of the Polyakov-Bershadsky W algebra, leading to a 3-field representation of the KP hierarchy already encountered in the literature. In such examples a rational algebra appears as algebra of constraints when reducing a KP hierarchy to a finite field representation. This fact arises the natural question whether rational algebras are always associated to such reductions and whether a classification of rational algebras can lead to a classification of the integrable hierarchies. (author). 19 refs

  4. Some Aspects of -Units in BCK-Algebras

    Directory of Open Access Journals (Sweden)

    Hee Sik Kim

    2012-01-01

    Full Text Available We explore properties of the set of d-units of a -algebra. A property of interest in the study of -units in -algebras is the weak associative property. It is noted that many other -algebras, especially -algebras, are in fact weakly associative. The existence of -algebras which are not weakly associative is demonstrated. Moreover, the notions of a -integral domain and a left-injectivity are discussed.

  5. Bases in Lie and quantum algebras

    International Nuclear Information System (INIS)

    Ballesteros, A; Celeghini, E; Olmo, M A del

    2008-01-01

    Applications of algebras in physics are related to the connection of measurable observables to relevant elements of the algebras, usually the generators. However, in the determination of the generators in Lie algebras there is place for some arbitrary conventions. The situation is much more involved in the context of quantum algebras, where inside the quantum universal enveloping algebra, we have not enough primitive elements that allow for a privileged set of generators and all basic sets are equivalent. In this paper we discuss how the Drinfeld double structure underlying every simple Lie bialgebra characterizes uniquely a particular basis without any freedom, completing the Cartan program on simple algebras. By means of a perturbative construction, a distinguished deformed basis (we call it the analytical basis) is obtained for every quantum group as the analytical prolongation of the above defined Lie basis of the corresponding Lie bialgebra. It turns out that the whole construction is unique, so to each quantum universal enveloping algebra is associated one and only one bialgebra. In this way the problem of the classification of quantum algebras is moved to the classification of bialgebras. In order to make this procedure more clear, we discuss in detail the simple cases of su(2) and su q (2).

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

  7. On Deformations and Contractions of Lie Algebras

    Directory of Open Access Journals (Sweden)

    Marc de Montigny

    2006-05-01

    Full Text Available In this contributed presentation, we discuss and compare the mutually opposite procedures of deformations and contractions of Lie algebras. We suggest that with appropriate combinations of both procedures one may construct new Lie algebras. We first discuss low-dimensional Lie algebras and illustrate thereby that whereas for every contraction there exists a reverse deformation, the converse is not true in general. Also we note that some Lie algebras belonging to parameterized families are singled out by the irreversibility of deformations and contractions. After reminding that global deformations of the Witt, Virasoro, and affine Kac-Moody algebras allow one to retrieve Lie algebras of Krichever-Novikov type, we contract the latter to find new infinite dimensional Lie algebras.

  8. Algebraic Description of Motion

    Science.gov (United States)

    Davidon, William C.

    1974-01-01

    An algebraic definition of time differentiation is presented and used to relate independent measurements of position and velocity. With this, students can grasp certain essential physical, geometric, and algebraic properties of motion and differentiation before undertaking the study of limits. (Author)

  9. A multilevel correction adaptive finite element method for Kohn-Sham equation

    Science.gov (United States)

    Hu, Guanghui; Xie, Hehu; Xu, Fei

    2018-02-01

    In this paper, an adaptive finite element method is proposed for solving Kohn-Sham equation with the multilevel correction technique. In the method, the Kohn-Sham equation is solved on a fixed and appropriately coarse mesh with the finite element method in which the finite element space is kept improving by solving the derived boundary value problems on a series of adaptively and successively refined meshes. A main feature of the method is that solving large scale Kohn-Sham system is avoided effectively, and solving the derived boundary value problems can be handled efficiently by classical methods such as the multigrid method. Hence, the significant acceleration can be obtained on solving Kohn-Sham equation with the proposed multilevel correction technique. The performance of the method is examined by a variety of numerical experiments.

  10. Deformation of the exterior algebra and the GLq (r, included in) algebra

    International Nuclear Information System (INIS)

    El Hassouni, A.; Hassouni, Y.; Zakkari, M.

    1993-06-01

    The deformation of the associative algebra of exterior forms is performed. This operation leads to a Y.B. equation. Its relation with the braid group B n-1 is analyzed. The correspondence of this deformation with the GL q (r, included in) algebra is developed. (author). 9 refs

  11. The Universal Askey-Wilson Algebra

    Directory of Open Access Journals (Sweden)

    Paul Terwilliger

    2011-07-01

    Full Text Available In 1992 A. Zhedanov introduced the Askey-Wilson algebra AW=AW(3 and used it to describe the Askey-Wilson polynomials. In this paper we introduce a central extension Δ of AW, obtained from AW by reinterpreting certain parameters as central elements in the algebra. We call Δ the universal Askey-Wilson algebra. We give a faithful action of the modular group PSL_2(Z on Δ as a group of automorphisms. We give a linear basis for Δ. We describe the center of Δ and the 2-sided ideal Δ[Δ,Δ]Δ. We discuss how Δ is related to the q-Onsager algebra.

  12. Linear algebra

    CERN Document Server

    Stoll, R R

    1968-01-01

    Linear Algebra is intended to be used as a text for a one-semester course in linear algebra at the undergraduate level. The treatment of the subject will be both useful to students of mathematics and those interested primarily in applications of the theory. The major prerequisite for mastering the material is the readiness of the student to reason abstractly. Specifically, this calls for an understanding of the fact that axioms are assumptions and that theorems are logical consequences of one or more axioms. Familiarity with calculus and linear differential equations is required for understand

  13. Lie algebras

    CERN Document Server

    Jacobson, Nathan

    1979-01-01

    Lie group theory, developed by M. Sophus Lie in the 19th century, ranks among the more important developments in modern mathematics. Lie algebras comprise a significant part of Lie group theory and are being actively studied today. This book, by Professor Nathan Jacobson of Yale, is the definitive treatment of the subject and can be used as a textbook for graduate courses.Chapter I introduces basic concepts that are necessary for an understanding of structure theory, while the following three chapters present the theory itself: solvable and nilpotent Lie algebras, Carlan's criterion and its

  14. Basic algebra

    CERN Document Server

    Jacobson, Nathan

    2009-01-01

    A classic text and standard reference for a generation, this volume and its companion are the work of an expert algebraist who taught at Yale for two decades. Nathan Jacobson's books possess a conceptual and theoretical orientation, and in addition to their value as classroom texts, they serve as valuable references.Volume I explores all of the topics typically covered in undergraduate courses, including the rudiments of set theory, group theory, rings, modules, Galois theory, polynomials, linear algebra, and associative algebra. Its comprehensive treatment extends to such rigorous topics as L

  15. Feature-Oriented Programming with Object Algebras

    NARCIS (Netherlands)

    B.C.d.S. Oliveira (Bruno); T. van der Storm (Tijs); A. Loh; W.R. Cook

    2013-01-01

    htmlabstractObject algebras are a new programming technique that enables a simple solution to basic extensibility and modularity issues in programming languages. While object algebras excel at defining modular features, the composition mechanisms for object algebras (and features) are still

  16. Representations of fundamental groups of algebraic varieties

    CERN Document Server

    Zuo, Kang

    1999-01-01

    Using harmonic maps, non-linear PDE and techniques from algebraic geometry this book enables the reader to study the relation between fundamental groups and algebraic geometry invariants of algebraic varieties. The reader should have a basic knowledge of algebraic geometry and non-linear analysis. This book can form the basis for graduate level seminars in the area of topology of algebraic varieties. It also contains present new techniques for researchers working in this area.

  17. Lie Algebras Associated with Group U(n)

    International Nuclear Information System (INIS)

    Zhang Yufeng; Dong Huanghe; Honwah Tam

    2007-01-01

    Starting from the subgroups of the group U(n), the corresponding Lie algebras of the Lie algebra A 1 are presented, from which two well-known simple equivalent matrix Lie algebras are given. It follows that a few expanding Lie algebras are obtained by enlarging matrices. Some of them can be devoted to producing double integrable couplings of the soliton hierarchies of nonlinear evolution equations. Others can be used to generate integrable couplings involving more potential functions. The above Lie algebras are classified into two types. Only one type can generate the integrable couplings, whose Hamiltonian structure could be obtained by use of the quadratic-form identity. In addition, one condition on searching for integrable couplings is improved such that more useful Lie algebras are enlightened to engender. Then two explicit examples are shown to illustrate the applications of the Lie algebras. Finally, with the help of closed cycling operation relations, another way of producing higher-dimensional Lie algebras is given.

  18. Smarandache hyper BCC-algebra

    OpenAIRE

    Ahadpanah, A.; Borumand Saeid, A.

    2011-01-01

    In this paper, we define the Smarandache hyper BCC-algebra, and Smarandache hyper BCC-ideals of type 1, 2, 3 and 4. We state and prove some theorems in Smarandache hyper BCC -algebras, and then we determine the relationships between these hyper ideals.

  19. ASYS: a computer algebra package for analysis of nonlinear algebraic equations systems

    International Nuclear Information System (INIS)

    Gerdt, V.P.; Khutornoj, N.V.

    1992-01-01

    A program package ASYS for analysis of nonlinear algebraic equations based on the Groebner basis technique is described. The package is written in REDUCE computer algebra language. It has special facilities to treat polynomial ideals of positive dimension, corresponding to algebraic systems with infinitely many solutions. Such systems can be transformed to an equivalent set of subsystems with reduced number of variables in completely automatic way. It often allows to construct the explicit form of a solution set in many problems of practical importance. Some examples and results of comparison with the standard Reduce package GROEBNER and special-purpose systems FELIX and A1PI are given. 21 refs.; 2 tabs

  20. The N=2 super-W3 algebra

    International Nuclear Information System (INIS)

    Romans, L.J.

    1992-01-01

    We present the complete structure of the N=2 super-W 3 algebra, a non-linear extended conformal algebra containing the usual N=2 superconformal algebra (with generators of spins 1, 3/2, 3/2 and 2) and a higher-spin multiplet of generators with spins 2, 5/2, 5/2 and 3. We investigate various sub-algebras and related algebras, and find necessary conditions upon possible unitary representations of the algebra. In particular, the central charge c is restricted to two discrete series, one ascending and one descending to a common accumulation point c=6. The results suggest that the algebra is realised in certain (compact or non-compact) Kazama-Suzuki coset models, including a c=9 model proposed by Bars based on SU(2, 1)/U(2). (orig.)