WorldWideScience

Sample records for finite element solver

  1. A finite element field solver for dipole modes

    International Nuclear Information System (INIS)

    Nelson, E.M.

    1992-01-01

    A finite element field solver for dipole modes in axisymmetric structures has been written. The second-order elements used in this formulation yield accurate mode frequencies with no spurious modes. Quasi-periodic boundaries are included to allow travelling waves in periodic structures. The solver is useful in applications requiring precise frequency calculations such as detuned accelerator structures for linear colliders. Comparisons are made with measurements and with the popular but less accurate field solver URMEL. (author). 7 refs., 4 figs

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

    International Nuclear Information System (INIS)

    Fang Jun; Gao Xingyu; Zhou Aihui

    2012-01-01

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

  3. Domain decomposition solvers for nonlinear multiharmonic finite element equations

    KAUST Repository

    Copeland, D. M.

    2010-01-01

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

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

    KAUST Repository

    Copeland, Dylan

    2010-10-05

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

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

    KAUST Repository

    Copeland, Dylan; Kolmbauer, Michael; Langer, Ulrich

    2010-01-01

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

  6. A parallel direct solver for the self-adaptive hp Finite Element Method

    KAUST Repository

    Paszyński, Maciej R.

    2010-03-01

    In this paper we present a new parallel multi-frontal direct solver, dedicated for the hp Finite Element Method (hp-FEM). The self-adaptive hp-FEM generates in a fully automatic mode, a sequence of hp-meshes delivering exponential convergence of the error with respect to the number of degrees of freedom (d.o.f.) as well as the CPU time, by performing a sequence of hp refinements starting from an arbitrary initial mesh. The solver constructs an initial elimination tree for an arbitrary initial mesh, and expands the elimination tree each time the mesh is refined. This allows us to keep track of the order of elimination for the solver. The solver also minimizes the memory usage, by de-allocating partial LU factorizations computed during the elimination stage of the solver, and recomputes them for the backward substitution stage, by utilizing only about 10% of the computational time necessary for the original computations. The solver has been tested on 3D Direct Current (DC) borehole resistivity measurement simulations problems. We measure the execution time and memory usage of the solver over a large regular mesh with 1.5 million degrees of freedom as well as on the highly non-regular mesh, generated by the self-adaptive h p-FEM, with finite elements of various sizes and polynomial orders of approximation varying from p = 1 to p = 9. From the presented experiments it follows that the parallel solver scales well up to the maximum number of utilized processors. The limit for the solver scalability is the maximum sequential part of the algorithm: the computations of the partial LU factorizations over the longest path, coming from the root of the elimination tree down to the deepest leaf. © 2009 Elsevier Inc. All rights reserved.

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

    CERN Document Server

    Nelson, Eric M

    2005-01-01

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

  8. Efficient CUDA Polynomial Preconditioned Conjugate Gradient Solver for Finite Element Computation of Elasticity Problems

    Directory of Open Access Journals (Sweden)

    Jianfei Zhang

    2013-01-01

    Full Text Available Graphics processing unit (GPU has obtained great success in scientific computations for its tremendous computational horsepower and very high memory bandwidth. This paper discusses the efficient way to implement polynomial preconditioned conjugate gradient solver for the finite element computation of elasticity on NVIDIA GPUs using compute unified device architecture (CUDA. Sliced block ELLPACK (SBELL format is introduced to store sparse matrix arising from finite element discretization of elasticity with fewer padding zeros than traditional ELLPACK-based formats. Polynomial preconditioning methods have been investigated both in convergence and running time. From the overall performance, the least-squares (L-S polynomial method is chosen as a preconditioner in PCG solver to finite element equations derived from elasticity for its best results on different example meshes. In the PCG solver, mixed precision algorithm is used not only to reduce the overall computational, storage requirements and bandwidth but to make full use of the capacity of the GPU devices. With SBELL format and mixed precision algorithm, the GPU-based L-S preconditioned CG can get a speedup of about 7–9 to CPU-implementation.

  9. The Use of Sparse Direct Solver in Vector Finite Element Modeling for Calculating Two Dimensional (2-D) Magnetotelluric Responses in Transverse Electric (TE) Mode

    Science.gov (United States)

    Yihaa Roodhiyah, Lisa’; Tjong, Tiffany; Nurhasan; Sutarno, D.

    2018-04-01

    The late research, linear matrices of vector finite element in two dimensional(2-D) magnetotelluric (MT) responses modeling was solved by non-sparse direct solver in TE mode. Nevertheless, there is some weakness which have to be improved especially accuracy in the low frequency (10-3 Hz-10-5 Hz) which is not achieved yet and high cost computation in dense mesh. In this work, the solver which is used is sparse direct solver instead of non-sparse direct solverto overcome the weaknesses of solving linear matrices of vector finite element metod using non-sparse direct solver. Sparse direct solver will be advantageous in solving linear matrices of vector finite element method because of the matrix properties which is symmetrical and sparse. The validation of sparse direct solver in solving linear matrices of vector finite element has been done for a homogen half-space model and vertical contact model by analytical solution. Thevalidation result of sparse direct solver in solving linear matrices of vector finite element shows that sparse direct solver is more stable than non-sparse direct solver in computing linear problem of vector finite element method especially in low frequency. In the end, the accuracy of 2D MT responses modelling in low frequency (10-3 Hz-10-5 Hz) has been reached out under the efficient allocation memory of array and less computational time consuming.

  10. A parallel direct solver for the self-adaptive hp Finite Element Method

    KAUST Repository

    Paszyński, Maciej R.; Pardo, David; Torres-Verdí n, Carlos; Demkowicz, Leszek F.; Calo, Victor M.

    2010-01-01

    measurement simulations problems. We measure the execution time and memory usage of the solver over a large regular mesh with 1.5 million degrees of freedom as well as on the highly non-regular mesh, generated by the self-adaptive h p-FEM, with finite elements

  11. Modeling hemodynamics in intracranial aneurysms: Comparing accuracy of CFD solvers based on finite element and finite volume schemes.

    Science.gov (United States)

    Botti, Lorenzo; Paliwal, Nikhil; Conti, Pierangelo; Antiga, Luca; Meng, Hui

    2018-06-01

    Image-based computational fluid dynamics (CFD) has shown potential to aid in the clinical management of intracranial aneurysms (IAs) but its adoption in the clinical practice has been missing, partially due to lack of accuracy assessment and sensitivity analysis. To numerically solve the flow-governing equations CFD solvers generally rely on two spatial discretization schemes: Finite Volume (FV) and Finite Element (FE). Since increasingly accurate numerical solutions are obtained by different means, accuracies and computational costs of FV and FE formulations cannot be compared directly. To this end, in this study we benchmark two representative CFD solvers in simulating flow in a patient-specific IA model: (1) ANSYS Fluent, a commercial FV-based solver and (2) VMTKLab multidGetto, a discontinuous Galerkin (dG) FE-based solver. The FV solver's accuracy is improved by increasing the spatial mesh resolution (134k, 1.1m, 8.6m and 68.5m tetrahedral element meshes). The dGFE solver accuracy is increased by increasing the degree of polynomials (first, second, third and fourth degree) on the base 134k tetrahedral element mesh. Solutions from best FV and dGFE approximations are used as baseline for error quantification. On average, velocity errors for second-best approximations are approximately 1cm/s for a [0,125]cm/s velocity magnitude field. Results show that high-order dGFE provide better accuracy per degree of freedom but worse accuracy per Jacobian non-zero entry as compared to FV. Cross-comparison of velocity errors demonstrates asymptotic convergence of both solvers to the same numerical solution. Nevertheless, the discrepancy between under-resolved velocity fields suggests that mesh independence is reached following different paths. This article is protected by copyright. All rights reserved.

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

  13. A finite different field solver for dipole modes

    International Nuclear Information System (INIS)

    Nelson, E.M.

    1992-08-01

    A finite element field solver for dipole modes in axisymmetric structures has been written. The second-order elements used in this formulation yield accurate mode frequencies with no spurious modes. Quasi-periodic boundaries are included to allow travelling waves in periodic structures. The solver is useful in applications requiring precise frequency calculations such as detuned accelerator structures for linear colliders. Comparisons are made with measurements and with the popular but less accurate field solver URMEL

  14. Computational complexity and memory usage for multi-frontal direct solvers used in p finite element analysis

    KAUST Repository

    Calo, Victor M.; Collier, Nathan; Pardo, David; Paszyński, Maciej R.

    2011-01-01

    The multi-frontal direct solver is the state of the art for the direct solution of linear systems. This paper provides computational complexity and memory usage estimates for the application of the multi-frontal direct solver algorithm on linear systems resulting from p finite elements. Specifically we provide the estimates for systems resulting from C0 polynomial spaces spanned by B-splines. The structured grid and uniform polynomial order used in isogeometric meshes simplifies the analysis.

  15. Computational complexity and memory usage for multi-frontal direct solvers used in p finite element analysis

    KAUST Repository

    Calo, Victor M.

    2011-05-14

    The multi-frontal direct solver is the state of the art for the direct solution of linear systems. This paper provides computational complexity and memory usage estimates for the application of the multi-frontal direct solver algorithm on linear systems resulting from p finite elements. Specifically we provide the estimates for systems resulting from C0 polynomial spaces spanned by B-splines. The structured grid and uniform polynomial order used in isogeometric meshes simplifies the analysis.

  16. Hybrid Direct and Iterative Solver with Library of Multi-criteria Optimal Orderings for h Adaptive Finite Element Method Computations

    KAUST Repository

    AbouEisha, Hassan M.

    2016-06-02

    In this paper we present a multi-criteria optimization of element partition trees and resulting orderings for multi-frontal solver algorithms executed for two dimensional h adaptive finite element method. In particular, the problem of optimal ordering of elimination of rows in the sparse matrices resulting from adaptive finite element method computations is reduced to the problem of finding of optimal element partition trees. Given a two dimensional h refined mesh, we find all optimal element partition trees by using the dynamic programming approach. An element partition tree defines a prescribed order of elimination of degrees of freedom over the mesh. We utilize three different metrics to estimate the quality of the element partition tree. As the first criterion we consider the number of floating point operations(FLOPs) performed by the multi-frontal solver. As the second criterion we consider the number of memory transfers (MEMOPS) performed by the multi-frontal solver algorithm. As the third criterion we consider memory usage (NONZEROS) of the multi-frontal direct solver. We show the optimization results for FLOPs vs MEMOPS as well as for the execution time estimated as FLOPs+100MEMOPS vs NONZEROS. We obtain Pareto fronts with multiple optimal trees, for each mesh, and for each refinement level. We generate a library of optimal elimination trees for small grids with local singularities. We also propose an algorithm that for a given large mesh with identified local sub-grids, each one with local singularity. We compute Schur complements over the sub-grids using the optimal trees from the library, and we submit the sequence of Schur complements into the iterative solver ILUPCG.

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

    Science.gov (United States)

    Xie, Yang; Ying, Jinyong; Xie, Dexuan

    2017-03-30

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

  18. Equilibrium Wall Model Implementation in a Nodal Finite Element Flow Solver JENRE for Large Eddy Simulations

    Science.gov (United States)

    2017-11-13

    finite element flow solver JENRE developed at the Naval Research Laboratory. The Crocco- Busemann relation is used to account for the compressibility. In...3 1. Comparison with the measurement data...Naval Research Laboratory. The Crocco-Busemann relation is used to account for the compressibility. In this wall-model implementation, the first

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

    International Nuclear Information System (INIS)

    Nelson, E.M.

    1993-12-01

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

  20. A Posteriori Error Estimation for Finite Element Methods and Iterative Linear Solvers

    Energy Technology Data Exchange (ETDEWEB)

    Melboe, Hallgeir

    2001-10-01

    This thesis addresses a posteriori error estimation for finite element methods and iterative linear solvers. Adaptive finite element methods have gained a lot of popularity over the last decades due to their ability to produce accurate results with limited computer power. In these methods a posteriori error estimates play an essential role. Not only do they give information about how large the total error is, they also indicate which parts of the computational domain should be given a more sophisticated treatment in order to reduce the error. A posteriori error estimates are traditionally aimed at estimating the global error, but more recently so called goal oriented error estimators have been shown a lot of interest. The name reflects the fact that they estimate the error in user-defined local quantities. In this thesis the main focus is on global error estimators for highly stretched grids and goal oriented error estimators for flow problems on regular grids. Numerical methods for partial differential equations, such as finite element methods and other similar techniques, typically result in a linear system of equations that needs to be solved. Usually such systems are solved using some iterative procedure which due to a finite number of iterations introduces an additional error. Most such algorithms apply the residual in the stopping criterion, whereas the control of the actual error may be rather poor. A secondary focus in this thesis is on estimating the errors that are introduced during this last part of the solution procedure. The thesis contains new theoretical results regarding the behaviour of some well known, and a few new, a posteriori error estimators for finite element methods on anisotropic grids. Further, a goal oriented strategy for the computation of forces in flow problems is devised and investigated. Finally, an approach for estimating the actual errors associated with the iterative solution of linear systems of equations is suggested. (author)

  1. High accuracy 3D electromagnetic finite element analysis

    International Nuclear Information System (INIS)

    Nelson, Eric M.

    1997-01-01

    A high accuracy 3D electromagnetic finite element field solver employing quadratic hexahedral elements and quadratic mixed-order one-form basis functions will be described. The solver is based on an object-oriented C++ class library. Test cases demonstrate that frequency errors less than 10 ppm can be achieved using modest workstations, and that the solutions have no contamination from spurious modes. The role of differential geometry and geometrical physics in finite element analysis will also be discussed

  2. High accuracy 3D electromagnetic finite element analysis

    International Nuclear Information System (INIS)

    Nelson, E.M.

    1996-01-01

    A high accuracy 3D electromagnetic finite element field solver employing quadratic hexahedral elements and quadratic mixed-order one-form basis functions will be described. The solver is based on an object-oriented C++ class library. Test cases demonstrate that frequency errors less than 10 ppm can be achieved using modest workstations, and that the solutions have no contamination from spurious modes. The role of differential geometry and geometrical physics in finite element analysis will also be discussed

  3. Advances in 3D electromagnetic finite element modeling

    International Nuclear Information System (INIS)

    Nelson, E.M.

    1997-01-01

    Numerous advances in electromagnetic finite element analysis (FEA) have been made in recent years. The maturity of frequency domain and eigenmode calculations, and the growth of time domain applications is briefly reviewed. A high accuracy 3D electromagnetic finite element field solver employing quadratic hexahedral elements and quadratic mixed-order one-form basis functions will also be described. The solver is based on an object-oriented C++ class library. Test cases demonstrate that frequency errors less than 10 ppm can be achieved using modest workstations, and that the solutions have no contamination from spurious modes. The role of differential geometry and geometrical physics in finite element analysis is also discussed

  4. High accuracy 3D electromagnetic finite element analysis

    International Nuclear Information System (INIS)

    Nelson, E.M.

    1997-01-01

    A high accuracy 3D electromagnetic finite element field solver employing quadratic hexahedral elements and quadratic mixed-order one-form basis functions will be described. The solver is based on an object-oriented C++ class library. Test cases demonstrate that frequency errors less than 10 ppm can be achieved using modest workstations, and that the solutions have no contamination from spurious modes. The role of differential geometry and geometrical physics in finite element analysis will also be discussed. copyright 1997 American Institute of Physics

  5. Primal Domain Decomposition Method with Direct and Iterative Solver for Circuit-Field-Torque Coupled Parallel Finite Element Method to Electric Machine Modelling

    Directory of Open Access Journals (Sweden)

    Daniel Marcsa

    2015-01-01

    Full Text Available The analysis and design of electromechanical devices involve the solution of large sparse linear systems, and require therefore high performance algorithms. In this paper, the primal Domain Decomposition Method (DDM with parallel forward-backward and with parallel Preconditioned Conjugate Gradient (PCG solvers are introduced in two-dimensional parallel time-stepping finite element formulation to analyze rotating machine considering the electromagnetic field, external circuit and rotor movement. The proposed parallel direct and the iterative solver with two preconditioners are analyzed concerning its computational efficiency and number of iterations of the solver with different preconditioners. Simulation results of a rotating machine is also presented.

  6. Inside finite elements

    CERN Document Server

    Weiser, Martin

    2016-01-01

    All relevant implementation aspects of finite element methods are discussed in this book. The focus is on algorithms and data structures as well as on their concrete implementation. Theory is covered as far as it gives insight into the construction of algorithms. Throughout the exercises a complete FE-solver for scalar 2D problems will be implemented in Matlab/Octave.

  7. Extending the Finite Domain Solver of GNU Prolog

    NARCIS (Netherlands)

    Bloemen, Vincent; Diaz, Daniel; van der Bijl, Machiel; Abreu, Salvador; Ströder, Thomas; Swift, Terrance

    This paper describes three significant extensions for the Finite Domain solver of GNU Prolog. First, the solver now supports negative integers. Second, the solver detects and prevents integer overflows from occurring. Third, the internal representation of sparse domains has been redesigned to

  8. A direct solver with reutilization of LU factorizations for h-adaptive finite element grids with point singularities

    KAUST Repository

    Paszyński, Maciej R.

    2013-04-01

    This paper describes a direct solver algorithm for a sequence of finite element meshes that are h-refined towards one or several point singularities. For such a sequence of grids, the solver delivers linear computational cost O(N) in terms of CPU time and memory with respect to the number of unknowns N. The linear computational cost is achieved by utilizing the recursive structure provided by the sequence of h-adaptive grids with a special construction of the elimination tree that allows for reutilization of previously computed partial LU (or Cholesky) factorizations over the entire unrefined part of the computational mesh. The reutilization technique reduces the computational cost of the entire sequence of h-refined grids from O(N2) down to O(N). Theoretical estimates are illustrated with numerical results on two- and three-dimensional model problems exhibiting one or several point singularities. © 2013 Elsevier Ltd. All rights reserved.

  9. A direct solver with reutilization of LU factorizations for h-adaptive finite element grids with point singularities

    KAUST Repository

    Paszyński, Maciej R.; Calo, Victor M.; Pardo, David

    2013-01-01

    This paper describes a direct solver algorithm for a sequence of finite element meshes that are h-refined towards one or several point singularities. For such a sequence of grids, the solver delivers linear computational cost O(N) in terms of CPU time and memory with respect to the number of unknowns N. The linear computational cost is achieved by utilizing the recursive structure provided by the sequence of h-adaptive grids with a special construction of the elimination tree that allows for reutilization of previously computed partial LU (or Cholesky) factorizations over the entire unrefined part of the computational mesh. The reutilization technique reduces the computational cost of the entire sequence of h-refined grids from O(N2) down to O(N). Theoretical estimates are illustrated with numerical results on two- and three-dimensional model problems exhibiting one or several point singularities. © 2013 Elsevier Ltd. All rights reserved.

  10. Parallel direct solver for finite element modeling of manufacturing processes

    DEFF Research Database (Denmark)

    Nielsen, Chris Valentin; Martins, P.A.F.

    2017-01-01

    The central processing unit (CPU) time is of paramount importance in finite element modeling of manufacturing processes. Because the most significant part of the CPU time is consumed in solving the main system of equations resulting from finite element assemblies, different approaches have been...

  11. The Cost of Continuity: Performance of Iterative Solvers on Isogeometric Finite Elements

    KAUST Repository

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

    2013-01-01

    In this paper we study how the use of a more continuous set of basis functions affects the cost of solving systems of linear equations resulting from a discretized Galerkin weak form. Specifically, we compare performance of linear solvers when discretizing using Co B-splines, which span traditional finite element spaces, and Cp-1 B-splines, which represent maximum continuity We provide theoretical estimates for the increase in cost of the matrix-vector product as well as for the construction and application of black-box preconditioners. We accompany these estimates with numerical results and study their sensitivity to various grid parameters such as element size h and polynomial order of approximation p in addition to the aforementioned continuity of the basis. Finally, we present timing results for a range of preconditioning options for the Laplace problem. We conclude that the matrix-vector product operation is at most 33p2/8 times more expensive for the more continuous space, although for moderately low p, this number is significantly reduced. Moreover, if static condensation is not employed, this number further reduces to at most a value of 8, even for high p. Preconditioning options can be up to p3 times more expensive to set up, although this difference significantly decreases for some popular preconditioners such as incomplete LU factorization. © 2013 Society for Industrial and Applied Mathematics.

  12. The Cost of Continuity: Performance of Iterative Solvers on Isogeometric Finite Elements

    KAUST Repository

    Collier, Nathan

    2013-03-19

    In this paper we study how the use of a more continuous set of basis functions affects the cost of solving systems of linear equations resulting from a discretized Galerkin weak form. Specifically, we compare performance of linear solvers when discretizing using Co B-splines, which span traditional finite element spaces, and Cp-1 B-splines, which represent maximum continuity We provide theoretical estimates for the increase in cost of the matrix-vector product as well as for the construction and application of black-box preconditioners. We accompany these estimates with numerical results and study their sensitivity to various grid parameters such as element size h and polynomial order of approximation p in addition to the aforementioned continuity of the basis. Finally, we present timing results for a range of preconditioning options for the Laplace problem. We conclude that the matrix-vector product operation is at most 33p2/8 times more expensive for the more continuous space, although for moderately low p, this number is significantly reduced. Moreover, if static condensation is not employed, this number further reduces to at most a value of 8, even for high p. Preconditioning options can be up to p3 times more expensive to set up, although this difference significantly decreases for some popular preconditioners such as incomplete LU factorization. © 2013 Society for Industrial and Applied Mathematics.

  13. A finite element primer for beginners the basics

    CERN Document Server

    Zohdi, Tarek I

    2014-01-01

    The purpose of this primer is to provide the basics of the Finite Element Method, primarily illustrated through a classical model problem, linearized elasticity. The topics covered are:(1) Weighted residual methods and Galerkin approximations,(2) A model problem for one-dimensional?linear elastostatics,(3) Weak formulations in one dimension,(4) Minimum principles in one dimension,(5) Error estimation in one dimension,(5) Construction of Finite Element basis functions in one dimension,(6) Gaussian Quadrature,(7) Iterative solvers and element by element data structures,(8) A model problem for th

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

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

  16. A parallel adaptive finite element simplified spherical harmonics approximation solver for frequency domain fluorescence molecular imaging

    International Nuclear Information System (INIS)

    Lu Yujie; Zhu Banghe; Rasmussen, John C; Sevick-Muraca, Eva M; Shen Haiou; Wang Ge

    2010-01-01

    Fluorescence molecular imaging/tomography may play an important future role in preclinical research and clinical diagnostics. Time- and frequency-domain fluorescence imaging can acquire more measurement information than the continuous wave (CW) counterpart, improving the image quality of fluorescence molecular tomography. Although diffusion approximation (DA) theory has been extensively applied in optical molecular imaging, high-order photon migration models need to be further investigated to match quantitation provided by nuclear imaging. In this paper, a frequency-domain parallel adaptive finite element solver is developed with simplified spherical harmonics (SP N ) approximations. To fully evaluate the performance of the SP N approximations, a fast time-resolved tetrahedron-based Monte Carlo fluorescence simulator suitable for complex heterogeneous geometries is developed using a convolution strategy to realize the simulation of the fluorescence excitation and emission. The validation results show that high-order SP N can effectively correct the modeling errors of the diffusion equation, especially when the tissues have high absorption characteristics or when high modulation frequency measurements are used. Furthermore, the parallel adaptive mesh evolution strategy improves the modeling precision and the simulation speed significantly on a realistic digital mouse phantom. This solver is a promising platform for fluorescence molecular tomography using high-order approximations to the radiative transfer equation.

  17. MP Salsa: a finite element computer program for reacting flow problems. Part 1--theoretical development

    Energy Technology Data Exchange (ETDEWEB)

    Shadid, J.N.; Moffat, H.K.; Hutchinson, S.A.; Hennigan, G.L.; Devine, K.D.; Salinger, A.G.

    1996-05-01

    The theoretical background for the finite element computer program, MPSalsa, is presented in detail. MPSalsa is designed to solve laminar, low Mach number, two- or three-dimensional incompressible and variable density reacting fluid flows on massively parallel computers, using a Petrov-Galerkin finite element formulation. The code has the capability to solve coupled fluid flow, heat transport, multicomponent species transport, and finite-rate chemical reactions, and to solver coupled multiple Poisson or advection-diffusion- reaction equations. The program employs the CHEMKIN library to provide a rigorous treatment of multicomponent ideal gas kinetics and transport. Chemical reactions occurring in the gas phase and on surfaces are treated by calls to CHEMKIN and SURFACE CHEMKIN, respectively. The code employs unstructured meshes, using the EXODUS II finite element data base suite of programs for its input and output files. MPSalsa solves both transient and steady flows by using fully implicit time integration, an inexact Newton method and iterative solvers based on preconditioned Krylov methods as implemented in the Aztec solver library.

  18. Implementation of a high performance parallel finite element micromagnetics package

    International Nuclear Information System (INIS)

    Scholz, W.; Suess, D.; Dittrich, R.; Schrefl, T.; Tsiantos, V.; Forster, H.; Fidler, J.

    2004-01-01

    A new high performance scalable parallel finite element micromagnetics package has been implemented. It includes solvers for static energy minimization, time integration of the Landau-Lifshitz-Gilbert equation, and the nudged elastic band method

  19. The finite element analysis program MSC Marc/Mentat a first introduction

    CERN Document Server

    Öchsner, Andreas

    2016-01-01

    Based on simple examples, this book offers a short introduction to the general-purpose finite element program MSC Marc, a specialized program for non-linear problems (implicit solver) distributed by the MSC Software Corporation, which is commonly used in academia and industry. Today the documentation of all finite element programs includes a variety of step-by-step examples of differing complexity, and in addition, all software companies offer professional workshops on different topics. As such, rather than competing with these, the book focuses on providing simple examples, often single-element problems, which can easily be related to the theory that is discussed in finite element lectures. This makes it an ideal companion book to classical introductory courses on the finite element method.

  20. A finite element perspective on nonlinear FFT-based micromechanical simulations

    NARCIS (Netherlands)

    Zeman, J.; de Geus, T.W.J.; Vondrejc, J.; Peerlings, R.H.J.; Geers, M.G.D.

    2017-01-01

    Fourier solvers have become efficient tools to establish structure-property relations in heterogeneous materials. Introduced as an alternative to the Finite Element (FE) method, they are based on fixed-point solutions of the Lippmann-Schwinger type integral equation. Their computational efficiency

  1. Sampling of finite elements for sparse recovery in large scale 3D electrical impedance tomography

    International Nuclear Information System (INIS)

    Javaherian, Ashkan; Moeller, Knut; Soleimani, Manuchehr

    2015-01-01

    This study proposes a method to improve performance of sparse recovery inverse solvers in 3D electrical impedance tomography (3D EIT), especially when the volume under study contains small-sized inclusions, e.g. 3D imaging of breast tumours. Initially, a quadratic regularized inverse solver is applied in a fast manner with a stopping threshold much greater than the optimum. Based on assuming a fixed level of sparsity for the conductivity field, finite elements are then sampled via applying a compressive sensing (CS) algorithm to the rough blurred estimation previously made by the quadratic solver. Finally, a sparse inverse solver is applied solely to the sampled finite elements, with the solution to the CS as its initial guess. The results show the great potential of the proposed CS-based sparse recovery in improving accuracy of sparse solution to the large-size 3D EIT. (paper)

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

    Energy Technology Data Exchange (ETDEWEB)

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

    2006-07-01

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

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

    International Nuclear Information System (INIS)

    Van Criekingen, S.

    2006-01-01

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

  4. Finite element analysis of the Girkmann problem using the modern hp-version and the classical h-version

    KAUST Repository

    Niemi, Antti; Babuška, Ivo M.; Pitkä ranta, Juhani; Demkowicz, Leszek F.

    2011-01-01

    elasticity theory and (2) by using a dimensionally reduced shell-ring model. In the first approach the problem is solved with a fully automatic hp-adaptive finite element solver whereas the classical h-version of the finite element method is used

  5. 3D finite element simulation of optical modes in VCSELs

    OpenAIRE

    Rozova, M.; Pomplun, J.; Zschiedrich, L.; Schmidt, F.; Burger, S.

    2011-01-01

    We present a finite element method (FEM) solver for computation of optical resonance modes in VCSELs. We perform a convergence study and demonstrate that high accuracies for 3D setups can be attained on standard computers. We also demonstrate simulations of thermo-optical effects in VCSELs.

  6. A finite element perspective on non-linear FFT-based micromechanical simulations

    NARCIS (Netherlands)

    Zeman, J.; de Geus, T.W.J.; Vondřejc, J.; Peerlings, R.H.J.; Geers, M.G.D.

    2016-01-01

    Fourier solvers have become efficient tools to establish structure-property relations in heterogeneous materials. Introduced as an alternative to the Finite Element (FE) method, they are based on fixed-point solutions of the Lippmann-Schwinger type integral equation. Their computational efficiency

  7. Towards Green Multi-frontal Solver for Adaptive Finite Element Method

    KAUST Repository

    AbbouEisha, H.

    2015-06-01

    In this paper we present the optimization of the energy consumption for the multi-frontal solver algorithm executed over two dimensional grids with point singularities. The multi-frontal solver algorithm is controlled by so-called elimination tree, defining the order of elimination of rows from particular frontal matrices, as well as order of memory transfers for Schur complement matrices. For a given mesh there are many possible elimination trees resulting in different number of floating point operations (FLOPs) of the solver or different amount of data trans- ferred via memory transfers. In this paper we utilize the dynamic programming optimization procedure and we compare elimination trees optimized with respect to FLOPs with elimination trees optimized with respect to energy consumption.

  8. Towards Green Multi-frontal Solver for Adaptive Finite Element Method

    KAUST Repository

    AbbouEisha, H.; Moshkov, Mikhail; Jopek, K.; Gepner, P.; Kitowski, J.; Paszyn'ski, M.

    2015-01-01

    In this paper we present the optimization of the energy consumption for the multi-frontal solver algorithm executed over two dimensional grids with point singularities. The multi-frontal solver algorithm is controlled by so-called elimination tree, defining the order of elimination of rows from particular frontal matrices, as well as order of memory transfers for Schur complement matrices. For a given mesh there are many possible elimination trees resulting in different number of floating point operations (FLOPs) of the solver or different amount of data trans- ferred via memory transfers. In this paper we utilize the dynamic programming optimization procedure and we compare elimination trees optimized with respect to FLOPs with elimination trees optimized with respect to energy consumption.

  9. Two-dimensional finite element neutron diffusion analysis using hierarchic shape functions

    International Nuclear Information System (INIS)

    Carpenter, D.C.

    1997-01-01

    Recent advances have been made in the use of p-type finite element method (FEM) for structural and fluid dynamics problems that hold promise for reactor physics problems. These advances include using hierarchic shape functions, element-by-element iterative solvers and more powerful mapping techniques. Use of the hierarchic shape functions allows greater flexibility and efficiency in implementing energy-dependent flux expansions and incorporating localized refinement of the solution space. The irregular matrices generated by the p-type FEM can be solved efficiently using element-by-element conjugate gradient iterative solvers. These solvers do not require storage of either the global or local stiffness matrices and can be highly vectorized. Mapping techniques based on blending function interpolation allow exact representation of curved boundaries using coarse element grids. These features were implemented in a developmental two-dimensional neutron diffusion program based on the use of hierarchic shape functions (FEM2DH). Several aspects in the effective use of p-type analysis were explored. Two choices of elemental preconditioning were examined--the proper selection of the polynomial shape functions and the proper number of functions to use. Of the five shape function polynomials tested, the integral Legendre functions were the most effective. The serendipity set of functions is preferable over the full tensor product set. Two global preconditioners were also examined--simple diagonal and incomplete Cholesky. The full effectiveness of the finite element methodology was demonstrated on a two-region, two-group cylindrical problem but solved in the x-y coordinate space, using a non-structured element grid. The exact, analytic eigenvalue solution was achieved with FEM2DH using various combinations of element grids and flux expansions

  10. Sensitivity analysis of the Galerkin finite element method neutron diffusion solver to the shape of the elements

    Energy Technology Data Exchange (ETDEWEB)

    Hosseini, Seyed Abolfaz [Dept. of Energy Engineering, Sharif University of Technology, Tehran (Iran, Islamic Republic of)

    2017-02-15

    The purpose of the present study is the presentation of the appropriate element and shape function in the solution of the neutron diffusion equation in two-dimensional (2D) geometries. To this end, the multigroup neutron diffusion equation is solved using the Galerkin finite element method in both rectangular and hexagonal reactor cores. The spatial discretization of the equation is performed using unstructured triangular and quadrilateral finite elements. Calculations are performed using both linear and quadratic approximations of shape function in the Galerkin finite element method, based on which results are compared. Using the power iteration method, the neutron flux distributions with the corresponding eigenvalue are obtained. The results are then validated against the valid results for IAEA-2D and BIBLIS-2D benchmark problems. To investigate the dependency of the results to the type and number of the elements, and shape function order, a sensitivity analysis of the calculations to the mentioned parameters is performed. It is shown that the triangular elements and second order of the shape function in each element give the best results in comparison to the other states.

  11. Modern solvers for Helmholtz problems

    CERN Document Server

    Tang, Jok; Vuik, Kees

    2017-01-01

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

  12. Finite-element analysis of elastic sound-proof coupling thermal state

    Science.gov (United States)

    Tsyss, V. G.; Strokov, I. M.; Sergaeva, M. Yu

    2018-01-01

    The aim is in calculated determining of the elastic rubber-metal element thermal state of soundproof coupling ship shafting under variable influence during loads in time. Thermal coupling calculation is performed with finite element method using NX Simens software with Nastran solver. As a result of studies, the following results were obtained: - a volumetric picture of the temperature distribution over the array of the deformed coupling body is obtained; - time to reach steady-state thermal coupling mode has been determined; - dependences of maximum temperature and time to reach state on the established operation mode on rotation frequency and ambient temperature are determined. The findings prove the conclusion that usage of finite element analysis modern software can significantly speed up problem solving.

  13. Goal-Oriented Self-Adaptive hp Finite Element Simulation of 3D DC Borehole Resistivity Simulations

    KAUST Repository

    Calo, Victor M.

    2011-05-14

    In this paper we present a goal-oriented self-adaptive hp Finite Element Method (hp-FEM) with shared data structures and a parallel multi-frontal direct solver. The algorithm automatically generates (without any user interaction) a sequence of meshes delivering exponential convergence of a prescribed quantity of interest with respect to the number of degrees of freedom. The sequence of meshes is generated from a given initial mesh, by performing h (breaking elements into smaller elements), p (adjusting polynomial orders of approximation) or hp (both) refinements on the finite elements. The new parallel implementation utilizes a computational mesh shared between multiple processors. All computational algorithms, including automatic hp goal-oriented adaptivity and the solver work fully in parallel. We describe the parallel self-adaptive hp-FEM algorithm with shared computational domain, as well as its efficiency measurements. We apply the methodology described to the three-dimensional simulation of the borehole resistivity measurement of direct current through casing in the presence of invasion.

  14. Using a satisfiability solver to identify deterministic finite state automata

    NARCIS (Netherlands)

    Heule, M.J.H.; Verwer, S.

    2009-01-01

    We present an exact algorithm for identification of deterministic finite automata (DFA) which is based on satisfiability (SAT) solvers. Despite the size of the low level SAT representation, our approach seems to be competitive with alternative techniques. Our contributions are threefold: First, we

  15. Parallel Solver for H(div) Problems Using Hybridization and AMG

    Energy Technology Data Exchange (ETDEWEB)

    Lee, Chak S. [Lawrence Livermore National Lab. (LLNL), Livermore, CA (United States); Vassilevski, Panayot S. [Lawrence Livermore National Lab. (LLNL), Livermore, CA (United States)

    2016-01-15

    In this paper, a scalable parallel solver is proposed for H(div) problems discretized by arbitrary order finite elements on general unstructured meshes. The solver is based on hybridization and algebraic multigrid (AMG). Unlike some previously studied H(div) solvers, the hybridization solver does not require discrete curl and gradient operators as additional input from the user. Instead, only some element information is needed in the construction of the solver. The hybridization results in a H1-equivalent symmetric positive definite system, which is then rescaled and solved by AMG solvers designed for H1 problems. Weak and strong scaling of the method are examined through several numerical tests. Our numerical results show that the proposed solver provides a promising alternative to ADS, a state-of-the-art solver [12], for H(div) problems. In fact, it outperforms ADS for higher order elements.

  16. Heat transfer model and finite element formulation for simulation of selective laser melting

    Science.gov (United States)

    Roy, Souvik; Juha, Mario; Shephard, Mark S.; Maniatty, Antoinette M.

    2017-10-01

    A novel approach and finite element formulation for modeling the melting, consolidation, and re-solidification process that occurs in selective laser melting additive manufacturing is presented. Two state variables are introduced to track the phase (melt/solid) and the degree of consolidation (powder/fully dense). The effect of the consolidation on the absorption of the laser energy into the material as it transforms from a porous powder to a dense melt is considered. A Lagrangian finite element formulation, which solves the governing equations on the unconsolidated reference configuration is derived, which naturally considers the effect of the changing geometry as the powder melts without needing to update the simulation domain. The finite element model is implemented into a general-purpose parallel finite element solver. Results are presented comparing to experimental results in the literature for a single laser track with good agreement. Predictions for a spiral laser pattern are also shown.

  17. Rigid body formulation in a finite element context with contact interaction

    Science.gov (United States)

    Refachinho de Campos, Paulo R.; Gay Neto, Alfredo

    2018-03-01

    The present work proposes a formulation to employ rigid bodies together with flexible bodies in the context of a nonlinear finite element solver, with contact interactions. Inertial contributions due to distribution of mass of a rigid body are fully developed, considering a general pole position associated with a single node, representing a rigid body element. Additionally, a mechanical constraint is proposed to connect a rigid region composed by several nodes, which is useful for linking rigid/flexible bodies in a finite element environment. Rodrigues rotation parameters are used to describe finite rotations, by an updated Lagrangian description. In addition, the contact formulation entitled master-surface to master-surface is employed in conjunction with the rigid body element and flexible bodies, aiming to consider their interaction in a rigid-flexible multibody environment. New surface parameterizations are presented to establish contact pairs, permitting pointwise interaction in a frictional scenario. Numerical examples are provided to show robustness and applicability of the methods.

  18. Matrix equation decomposition and parallel solution of systems resulting from unstructured finite element problems in electromagnetics

    Energy Technology Data Exchange (ETDEWEB)

    Cwik, T. [California Institute of Technology, Pasadena, CA (United States); Katz, D.S. [Cray Research, El Segundo, CA (United States)

    1996-12-31

    Finite element modeling has proven useful for accurately simulating scattered or radiated electromagnetic fields from complex three-dimensional objects whose geometry varies on the scale of a fraction of an electrical wavelength. An unstructured finite element model of realistic objects leads to a large, sparse, system of equations that needs to be solved efficiently with regard to machine memory and execution time. Both factorization and iterative solvers can be used to produce solutions to these systems of equations. Factorization leads to high memory requirements that limit the electrical problem size of three-dimensional objects that can be modeled. An iterative solver can be used to efficiently solve the system without excessive memory use and in a minimal amount of time if the convergence rate is controlled.

  19. Optimization of tissue physical parameters for accurate temperature estimation from finite-element simulation of radiofrequency ablation

    International Nuclear Information System (INIS)

    Subramanian, Swetha; Mast, T Douglas

    2015-01-01

    Computational finite element models are commonly used for the simulation of radiofrequency ablation (RFA) treatments. However, the accuracy of these simulations is limited by the lack of precise knowledge of tissue parameters. In this technical note, an inverse solver based on the unscented Kalman filter (UKF) is proposed to optimize values for specific heat, thermal conductivity, and electrical conductivity resulting in accurately simulated temperature elevations. A total of 15 RFA treatments were performed on ex vivo bovine liver tissue. For each RFA treatment, 15 finite-element simulations were performed using a set of deterministically chosen tissue parameters to estimate the mean and variance of the resulting tissue ablation. The UKF was implemented as an inverse solver to recover the specific heat, thermal conductivity, and electrical conductivity corresponding to the measured area of the ablated tissue region, as determined from gross tissue histology. These tissue parameters were then employed in the finite element model to simulate the position- and time-dependent tissue temperature. Results show good agreement between simulated and measured temperature. (note)

  20. Optimization of tissue physical parameters for accurate temperature estimation from finite-element simulation of radiofrequency ablation.

    Science.gov (United States)

    Subramanian, Swetha; Mast, T Douglas

    2015-10-07

    Computational finite element models are commonly used for the simulation of radiofrequency ablation (RFA) treatments. However, the accuracy of these simulations is limited by the lack of precise knowledge of tissue parameters. In this technical note, an inverse solver based on the unscented Kalman filter (UKF) is proposed to optimize values for specific heat, thermal conductivity, and electrical conductivity resulting in accurately simulated temperature elevations. A total of 15 RFA treatments were performed on ex vivo bovine liver tissue. For each RFA treatment, 15 finite-element simulations were performed using a set of deterministically chosen tissue parameters to estimate the mean and variance of the resulting tissue ablation. The UKF was implemented as an inverse solver to recover the specific heat, thermal conductivity, and electrical conductivity corresponding to the measured area of the ablated tissue region, as determined from gross tissue histology. These tissue parameters were then employed in the finite element model to simulate the position- and time-dependent tissue temperature. Results show good agreement between simulated and measured temperature.

  1. Accurate evaluation of exchange fields in finite element micromagnetic solvers

    Science.gov (United States)

    Chang, R.; Escobar, M. A.; Li, S.; Lubarda, M. V.; Lomakin, V.

    2012-04-01

    Quadratic basis functions (QBFs) are implemented for solving the Landau-Lifshitz-Gilbert equation via the finite element method. This involves the introduction of a set of special testing functions compatible with the QBFs for evaluating the Laplacian operator. The results by using QBFs are significantly more accurate than those via linear basis functions. QBF approach leads to significantly more accurate results than conventionally used approaches based on linear basis functions. Importantly QBFs allow reducing the error of computing the exchange field by increasing the mesh density for structured and unstructured meshes. Numerical examples demonstrate the feasibility of the method.

  2. PDE-based geophysical modelling using finite elements: examples from 3D resistivity and 2D magnetotellurics

    International Nuclear Information System (INIS)

    Schaa, R; Gross, L; Du Plessis, J

    2016-01-01

    We present a general finite-element solver, escript, tailored to solve geophysical forward and inverse modeling problems in terms of partial differential equations (PDEs) with suitable boundary conditions. Escript’s abstract interface allows geoscientists to focus on solving the actual problem without being experts in numerical modeling. General-purpose finite element solvers have found wide use especially in engineering fields and find increasing application in the geophysical disciplines as these offer a single interface to tackle different geophysical problems. These solvers are useful for data interpretation and for research, but can also be a useful tool in educational settings. This paper serves as an introduction into PDE-based modeling with escript where we demonstrate in detail how escript is used to solve two different forward modeling problems from applied geophysics (3D DC resistivity and 2D magnetotellurics). Based on these two different cases, other geophysical modeling work can easily be realized. The escript package is implemented as a Python library and allows the solution of coupled, linear or non-linear, time-dependent PDEs. Parallel execution for both shared and distributed memory architectures is supported and can be used without modifications to the scripts. (paper)

  3. PDE-based geophysical modelling using finite elements: examples from 3D resistivity and 2D magnetotellurics

    Science.gov (United States)

    Schaa, R.; Gross, L.; du Plessis, J.

    2016-04-01

    We present a general finite-element solver, escript, tailored to solve geophysical forward and inverse modeling problems in terms of partial differential equations (PDEs) with suitable boundary conditions. Escript’s abstract interface allows geoscientists to focus on solving the actual problem without being experts in numerical modeling. General-purpose finite element solvers have found wide use especially in engineering fields and find increasing application in the geophysical disciplines as these offer a single interface to tackle different geophysical problems. These solvers are useful for data interpretation and for research, but can also be a useful tool in educational settings. This paper serves as an introduction into PDE-based modeling with escript where we demonstrate in detail how escript is used to solve two different forward modeling problems from applied geophysics (3D DC resistivity and 2D magnetotellurics). Based on these two different cases, other geophysical modeling work can easily be realized. The escript package is implemented as a Python library and allows the solution of coupled, linear or non-linear, time-dependent PDEs. Parallel execution for both shared and distributed memory architectures is supported and can be used without modifications to the scripts.

  4. Solution of problems with material nonlinearities with a coupled finite element/boundary element scheme using an iterative solver. Yucca Mountain Site Characterization Project

    International Nuclear Information System (INIS)

    Koteras, J.R.

    1996-01-01

    The prediction of stresses and displacements around tunnels buried deep within the earth is an important class of geomechanics problems. The material behavior immediately surrounding the tunnel is typically nonlinear. The surrounding mass, even if it is nonlinear, can usually be characterized by a simple linear elastic model. The finite element method is best suited for modeling nonlinear materials of limited volume, while the boundary element method is well suited for modeling large volumes of linear elastic material. A computational scheme that couples the finite element and boundary element methods would seem particularly useful for geomechanics problems. A variety of coupling schemes have been proposed, but they rely on direct solution methods. Direct solution techniques have large storage requirements that become cumbersome for large-scale three-dimensional problems. An alternative to direct solution methods is iterative solution techniques. A scheme has been developed for coupling the finite element and boundary element methods that uses an iterative solution method. This report shows that this coupling scheme is valid for problems where nonlinear material behavior occurs in the finite element region

  5. Advanced finite element simulation with MSC Marc application of user subroutines

    CERN Document Server

    Javanbakht, Zia

    2017-01-01

    This book offers an in-depth insight into the general-purpose finite element program MSC Marc, which is distributed by MSC Software Corporation. It is a specialized program for nonlinear problems (implicit solver) which is common in academia and industry. The primary goal of this book is to provide a comprehensive introduction to a special feature of this software: the user can write user-subroutines in the programming language Fortran, which is the language of all classical finite element packages. This subroutine feature allows the user to replace certain modules of the core code and to implement new features such as constitutive laws or new elements. Thus, the functionality of commercial codes (‘black box’) can easily be extended by linking user written code to the main core of the program. This feature allows to take advantage of a commercial software package with the flexibility of a ‘semi-open’ code. .

  6. Finite element analysis of the Girkmann problem using the modern hp-version and the classical h-version

    KAUST Repository

    Niemi, Antti

    2011-06-03

    We perform finite element analysis of the so called Girkmann problem in structural mechanics. The problem involves an axially symmetric spherical shell stiffened with a foot ring and is approached (1) by using the axisymmetric formulation of linear elasticity theory and (2) by using a dimensionally reduced shell-ring model. In the first approach the problem is solved with a fully automatic hp-adaptive finite element solver whereas the classical h-version of the finite element method is used in the second approach. We study the convergence behaviour of the different numerical models and show that accurate stress resultants can be obtained with both models by using effective post-processing formulas. © Springer-Verlag London Limited 2011.

  7. Use of the iterative solution method for coupled finite element and boundary element modeling

    International Nuclear Information System (INIS)

    Koteras, J.R.

    1993-07-01

    Tunnels buried deep within the earth constitute an important class geomechanics problems. Two numerical techniques used for the analysis of geomechanics problems, the finite element method and the boundary element method, have complementary characteristics for applications to problems of this type. The usefulness of combining these two methods for use as a geomechanics analysis tool has been recognized for some time, and a number of coupling techniques have been proposed. However, not all of them lend themselves to efficient computational implementations for large-scale problems. This report examines a coupling technique that can form the basis for an efficient analysis tool for large scale geomechanics problems through the use of an iterative equation solver

  8. Ramses-GPU: Second order MUSCL-Handcock finite volume fluid solver

    Science.gov (United States)

    Kestener, Pierre

    2017-10-01

    RamsesGPU is a reimplementation of RAMSES (ascl:1011.007) which drops the adaptive mesh refinement (AMR) features to optimize 3D uniform grid algorithms for modern graphics processor units (GPU) to provide an efficient software package for astrophysics applications that do not need AMR features but do require a very large number of integration time steps. RamsesGPU provides an very efficient C++/CUDA/MPI software implementation of a second order MUSCL-Handcock finite volume fluid solver for compressible hydrodynamics as a magnetohydrodynamics solver based on the constraint transport technique. Other useful modules includes static gravity, dissipative terms (viscosity, resistivity), and forcing source term for turbulence studies, and special care was taken to enhance parallel input/output performance by using state-of-the-art libraries such as HDF5 and parallel-netcdf.

  9. Linear optical response of finite systems using multishift linear system solvers

    Energy Technology Data Exchange (ETDEWEB)

    Hübener, Hannes; Giustino, Feliciano [Department of Materials, University of Oxford, Oxford OX1 3PH (United Kingdom)

    2014-07-28

    We discuss the application of multishift linear system solvers to linear-response time-dependent density functional theory. Using this technique the complete frequency-dependent electronic density response of finite systems to an external perturbation can be calculated at the cost of a single solution of a linear system via conjugate gradients. We show that multishift time-dependent density functional theory yields excitation energies and oscillator strengths in perfect agreement with the standard diagonalization of the response matrix (Casida's method), while being computationally advantageous. We present test calculations for benzene, porphin, and chlorophyll molecules. We argue that multishift solvers may find broad applicability in the context of excited-state calculations within density-functional theory and beyond.

  10. Solution of finite element problems using hybrid parallelization with MPI and OpenMP Solution of finite element problems using hybrid parallelization with MPI and OpenMP

    Directory of Open Access Journals (Sweden)

    José Miguel Vargas-Félix

    2012-11-01

    Full Text Available The Finite Element Method (FEM is used to solve problems like solid deformation and heat diffusion in domains with complex geometries. This kind of geometries requires discretization with millions of elements; this is equivalent to solve systems of equations with sparse matrices and tens or hundreds of millions of variables. The aim is to use computer clusters to solve these systems. The solution method used is Schur substructuration. Using it is possible to divide a large system of equations into many small ones to solve them more efficiently. This method allows parallelization. MPI (Message Passing Interface is used to distribute the systems of equations to solve each one in a computer of a cluster. Each system of equations is solved using a solver implemented to use OpenMP as a local parallelization method.The Finite Element Method (FEM is used to solve problems like solid deformation and heat diffusion in domains with complex geometries. This kind of geometries requires discretization with millions of elements; this is equivalent to solve systems of equations with sparse matrices and tens or hundreds of millions of variables. The aim is to use computer clusters to solve these systems. The solution method used is Schur substructuration. Using it is possible to divide a large system of equations into many small ones to solve them more efficiently. This method allows parallelization. MPI (Message Passing Interface is used to distribute the systems of equations to solve each one in a computer of a cluster. Each system of equations is solved using a solver implemented to use OpenMP as a local parallelization method.

  11. Simulation of incompressible flows with heat and mass transfer using parallel finite element method

    Directory of Open Access Journals (Sweden)

    Jalal Abedi

    2003-02-01

    Full Text Available The stabilized finite element formulations based on the SUPG (Stream-line-Upwind/Petrov-Galerkin and PSPG (Pressure-Stabilization/Petrov-Galerkin methods are developed and applied to solve buoyancy-driven incompressible flows with heat and mass transfer. The SUPG stabilization term allows us to solve flow problems at high speeds (advection dominant flows and the PSPG term eliminates instabilities associated with the use of equal order interpolation functions for both pressure and velocity. The finite element formulations are implemented in parallel using MPI. In parallel computations, the finite element mesh is partitioned into contiguous subdomains using METIS, which are then assigned to individual processors. To ensure a balanced load, the number of elements assigned to each processor is approximately equal. To solve nonlinear systems in large-scale applications, we developed a matrix-free GMRES iterative solver. Here we totally eliminate a need to form any matrices, even at the element levels. To measure the accuracy of the method, we solve 2D and 3D example of natural convection flows at moderate to high Rayleigh numbers.

  12. Graph Grammar-Based Multi-Frontal Parallel Direct Solver for Two-Dimensional Isogeometric Analysis

    KAUST Repository

    Kuźnik, Krzysztof

    2012-06-02

    This paper introduces the graph grammar based model for developing multi-thread multi-frontal parallel direct solver for two dimensional isogeometric finite element method. Execution of the solver algorithm has been expressed as the sequence of graph grammar productions. At the beginning productions construct the elimination tree with leaves corresponding to finite elements. Following sequence of graph grammar productions generates element frontal matri-ces at leaf nodes, merges matrices at parent nodes and eliminates rows corresponding to fully assembled degrees of freedom. Finally, there are graph grammar productions responsible for root problem solution and recursive backward substitutions. Expressing the solver algorithm by graph grammar productions allows us to explore the concurrency of the algorithm. The graph grammar productions are grouped into sets of independent tasks that can be executed concurrently. The resulting concurrent multi-frontal solver algorithm is implemented and tested on NVIDIA GPU, providing O(NlogN) execution time complexity where N is the number of degrees of freedom. We have confirmed this complexity by solving up to 1 million of degrees of freedom with 448 cores GPU.

  13. Numerical Study on Several Stabilized Finite Element Methods for the Steady Incompressible Flow Problem with Damping

    Directory of Open Access Journals (Sweden)

    Jilian Wu

    2013-01-01

    Full Text Available We discuss several stabilized finite element methods, which are penalty, regular, multiscale enrichment, and local Gauss integration method, for the steady incompressible flow problem with damping based on the lowest equal-order finite element space pair. Then we give the numerical comparisons between them in three numerical examples which show that the local Gauss integration method has good stability, efficiency, and accuracy properties and it is better than the others for the steady incompressible flow problem with damping on the whole. However, to our surprise, the regular method spends less CPU-time and has better accuracy properties by using Crout solver.

  14. Basic Finite Element Method

    International Nuclear Information System (INIS)

    Lee, Byeong Hae

    1992-02-01

    This book gives descriptions of basic finite element method, which includes basic finite element method and data, black box, writing of data, definition of VECTOR, definition of matrix, matrix and multiplication of matrix, addition of matrix, and unit matrix, conception of hardness matrix like spring power and displacement, governed equation of an elastic body, finite element method, Fortran method and programming such as composition of computer, order of programming and data card and Fortran card, finite element program and application of nonelastic problem.

  15. A Stabilized Finite Element Method for Modified Poisson-Nernst-Planck Equations to Determine Ion Flow Through a Nanopore

    Science.gov (United States)

    Chaudhry, Jehanzeb Hameed; Comer, Jeffrey; Aksimentiev, Aleksei; Olson, Luke N.

    2013-01-01

    The conventional Poisson-Nernst-Planck equations do not account for the finite size of ions explicitly. This leads to solutions featuring unrealistically high ionic concentrations in the regions subject to external potentials, in particular, near highly charged surfaces. A modified form of the Poisson-Nernst-Planck equations accounts for steric effects and results in solutions with finite ion concentrations. Here, we evaluate numerical methods for solving the modified Poisson-Nernst-Planck equations by modeling electric field-driven transport of ions through a nanopore. We describe a novel, robust finite element solver that combines the applications of the Newton's method to the nonlinear Galerkin form of the equations, augmented with stabilization terms to appropriately handle the drift-diffusion processes. To make direct comparison with particle-based simulations possible, our method is specifically designed to produce solutions under periodic boundary conditions and to conserve the number of ions in the solution domain. We test our finite element solver on a set of challenging numerical experiments that include calculations of the ion distribution in a volume confined between two charged plates, calculations of the ionic current though a nanopore subject to an external electric field, and modeling the effect of a DNA molecule on the ion concentration and nanopore current. PMID:24363784

  16. Implementation of second moment closure turbulence model for incompressible flows in the industrial finite element code N3S

    International Nuclear Information System (INIS)

    Pot, G.; Laurence, D.; Rharif, N.E.; Leal de Sousa, L.; Compe, C.

    1995-12-01

    This paper deals with the introduction of a second moment closure turbulence model (Reynolds Stress Model) in an industrial finite element code, N3S, developed at Electricite de France.The numerical implementation of the model in N3S will be detailed in 2D and 3D. Some details are given concerning finite element computations and solvers. Then, some results will be given, including a comparison between standard k-ε model, R.S.M. model and experimental data for some test case. (authors). 22 refs., 3 figs

  17. Finite element method for time-space-fractional Schrodinger equation

    Directory of Open Access Journals (Sweden)

    Xiaogang Zhu

    2017-07-01

    Full Text Available In this article, we develop a fully discrete finite element method for the nonlinear Schrodinger equation (NLS with time- and space-fractional derivatives. The time-fractional derivative is described in Caputo's sense and the space-fractional derivative in Riesz's sense. Its stability is well derived; the convergent estimate is discussed by an orthogonal operator. We also extend the method to the two-dimensional time-space-fractional NLS and to avoid the iterative solvers at each time step, a linearized scheme is further conducted. Several numerical examples are implemented finally, which confirm the theoretical results as well as illustrate the accuracy of our methods.

  18. Multilayer shallow shelf approximation: Minimisation formulation, finite element solvers and applications

    Energy Technology Data Exchange (ETDEWEB)

    Jouvet, Guillaume, E-mail: jouvet@vaw.baug.ethz.ch [Institut für Mathematik, Freie Universität Berlin (Germany); Laboratory of Hydraulics, Hydrology and Glaciology, ETH Zurich (Switzerland)

    2015-04-15

    In this paper, a multilayer generalisation of the Shallow Shelf Approximation (SSA) is considered. In this recent hybrid ice flow model, the ice thickness is divided into thin layers, which can spread out, contract and slide over each other in such a way that the velocity profile is layer-wise constant. Like the SSA (1-layer model), the multilayer model can be reformulated as a minimisation problem. However, unlike the SSA, the functional to be minimised involves a new penalisation term for the interlayer jumps of the velocity, which represents the vertical shear stresses induced by interlayer sliding. Taking advantage of this reformulation, numerical solvers developed for the SSA can be naturally extended layer-wise or column-wise. Numerical results show that the column-wise extension of a Newton multigrid solver proves to be robust in the sense that its convergence is barely influenced by the number of layers and the type of ice flow. In addition, the multilayer formulation appears to be naturally better conditioned than the one of the first-order approximation to face the anisotropic conditions of the sliding-dominant ice flow of ISMIP-HOM experiments.

  19. Accuracy of finite-element models for the stress analysis of multiple-holed moderator blocks

    International Nuclear Information System (INIS)

    Smith, P.D.; Sullivan, R.M.; Lewis, A.C.; Yu, H.J.

    1981-01-01

    Two steps have been taken to quantify and improve the accuracy in the analysis. First, the limitations of various approximation techniques have been studied with the aid of smaller benchmark problems containing fewer holes. Second, a new family of computer programs has been developed for handling such large problems. This paper describes the accuracy studies and the benchmark problems. A review is given of some proposed modeling techniques including local mesh refinement, homogenization, a special-purpose finite element, and substructuring. Some limitations of these approaches are discussed. The new finite element programs and the features that contribute to their efficiency are discussed. These include a standard architecture for out-of-core data processing and an equation solver that operates on a peripheral array processor. The central conclusions of the paper are: (1) modeling approximation methods such as local mesh refinement and homogenization tend to be unreliable, and they should be justified by a fine mesh benchmark analysis; and (2) finite element codes are now available that can achieve accurate solutions at a reasonable cost, and there is no longer a need to employ modeling approximations in the two-dimensional analysis of HTGR fuel elements. 10 figures

  20. Generalized finite elements

    International Nuclear Information System (INIS)

    Wachspress, E.

    2009-01-01

    Triangles and rectangles are the ubiquitous elements in finite element studies. Only these elements admit polynomial basis functions. Rational functions provide a basis for elements having any number of straight and curved sides. Numerical complexities initially associated with rational bases precluded extensive use. Recent analysis has reduced these difficulties and programs have been written to illustrate effectiveness. Although incorporation in major finite element software requires considerable effort, there are advantages in some applications which warrant implementation. An outline of the basic theory and of recent innovations is presented here. (authors)

  1. Parallelized Three-Dimensional Resistivity Inversion Using Finite Elements And Adjoint State Methods

    Science.gov (United States)

    Schaa, Ralf; Gross, Lutz; Du Plessis, Jaco

    2015-04-01

    The resistivity method is one of the oldest geophysical exploration methods, which employs one pair of electrodes to inject current into the ground and one or more pairs of electrodes to measure the electrical potential difference. The potential difference is a non-linear function of the subsurface resistivity distribution described by an elliptic partial differential equation (PDE) of the Poisson type. Inversion of measured potentials solves for the subsurface resistivity represented by PDE coefficients. With increasing advances in multichannel resistivity acquisition systems (systems with more than 60 channels and full waveform recording are now emerging), inversion software require efficient storage and solver algorithms. We developed the finite element solver Escript, which provides a user-friendly programming environment in Python to solve large-scale PDE-based problems (see https://launchpad.net/escript-finley). Using finite elements, highly irregular shaped geology and topography can readily be taken into account. For the 3D resistivity problem, we have implemented the secondary potential approach, where the PDE is decomposed into a primary potential caused by the source current and the secondary potential caused by changes in subsurface resistivity. The primary potential is calculated analytically, and the boundary value problem for the secondary potential is solved using nodal finite elements. This approach removes the singularity caused by the source currents and provides more accurate 3D resistivity models. To solve the inversion problem we apply a 'first optimize then discretize' approach using the quasi-Newton scheme in form of the limited-memory Broyden-Fletcher-Goldfarb-Shanno (L-BFGS) method (see Gross & Kemp 2013). The evaluation of the cost function requires the solution of the secondary potential PDE for each source current and the solution of the corresponding adjoint-state PDE for the cost function gradients with respect to the subsurface

  2. Sparse direct solver for large finite element problems based on the minimum degree algorithm

    Czech Academy of Sciences Publication Activity Database

    Pařík, Petr; Plešek, Jiří

    2017-01-01

    Roč. 113, November (2017), s. 2-6 ISSN 0965-9978 R&D Projects: GA ČR(CZ) GA15-20666S; GA MŠk(CZ) EF15_003/0000493 Institutional support: RVO:61388998 Keywords : sparse direct solution * finite element method * large sparse Linear systems Subject RIV: JR - Other Machinery OBOR OECD: Mechanical engineering Impact factor: 3.000, year: 2016 https://www.sciencedirect.com/science/article/pii/S0965997817302582

  3. Time-Domain Finite Elements for Virtual Testing of Electromagnetic Compatibility

    Directory of Open Access Journals (Sweden)

    V. Sedenka

    2013-04-01

    Full Text Available The paper presents a time-domain finite-element solver developed for simulations related to solving electromagnetic compatibility issues. The software is applied as a module integrated into a computational framework developed within a FP7 European project High Intensity Radiated Field – Synthetic Environment (HIRF SE able to simulate a large class of problems. In the paper, the mathematical formulation is briefly presented, and special emphasis is put on the user point of view on the simulation tool-chain. The functionality is demonstrated on the computation of shielding effectiveness of two composite materials. Results are validated through experimental measurements and agreement is confirmed by automatic feature selective algorithms.

  4. Element Partition Trees For H-Refined Meshes to Optimize Direct Solver Performance. Part I: Dynamic Programming

    KAUST Repository

    AbouEisha, Hassan M.

    2017-07-13

    We consider a class of two-and three-dimensional h-refined meshes generated by an adaptive finite element method. We introduce an element partition tree, which controls the execution of the multi-frontal solver algorithm over these refined grids. We propose and study algorithms with polynomial computational cost for the optimization of these element partition trees. The trees provide an ordering for the elimination of unknowns. The algorithms automatically optimize the element partition trees using extensions of dynamic programming. The construction of the trees by the dynamic programming approach is expensive. These generated trees cannot be used in practice, but rather utilized as a learning tool to propose fast heuristic algorithms. In this first part of our paper we focus on the dynamic programming approach, and draw a sketch of the heuristic algorithm. The second part will be devoted to a more detailed analysis of the heuristic algorithm extended for the case of hp-adaptive

  5. Element Partition Trees For H-Refined Meshes to Optimize Direct Solver Performance. Part I: Dynamic Programming

    KAUST Repository

    AbouEisha, Hassan M.; Calo, Victor Manuel; Jopek, Konrad; Moshkov, Mikhail; Paszyńka, Anna; Paszyński, Maciej; Skotniczny, Marcin

    2017-01-01

    We consider a class of two-and three-dimensional h-refined meshes generated by an adaptive finite element method. We introduce an element partition tree, which controls the execution of the multi-frontal solver algorithm over these refined grids. We propose and study algorithms with polynomial computational cost for the optimization of these element partition trees. The trees provide an ordering for the elimination of unknowns. The algorithms automatically optimize the element partition trees using extensions of dynamic programming. The construction of the trees by the dynamic programming approach is expensive. These generated trees cannot be used in practice, but rather utilized as a learning tool to propose fast heuristic algorithms. In this first part of our paper we focus on the dynamic programming approach, and draw a sketch of the heuristic algorithm. The second part will be devoted to a more detailed analysis of the heuristic algorithm extended for the case of hp-adaptive

  6. Parallel Auxiliary Space AMG Solver for $H(div)$ Problems

    Energy Technology Data Exchange (ETDEWEB)

    Kolev, Tzanio V. [Lawrence Livermore National Lab. (LLNL), Livermore, CA (United States); Vassilevski, Panayot S. [Lawrence Livermore National Lab. (LLNL), Livermore, CA (United States)

    2012-12-18

    We present a family of scalable preconditioners for matrices arising in the discretization of $H(div)$ problems using the lowest order Raviart--Thomas finite elements. Our approach belongs to the class of “auxiliary space''--based methods and requires only the finite element stiffness matrix plus some minimal additional discretization information about the topology and orientation of mesh entities. Also, we provide a detailed algebraic description of the theory, parallel implementation, and different variants of this parallel auxiliary space divergence solver (ADS) and discuss its relations to the Hiptmair--Xu (HX) auxiliary space decomposition of $H(div)$ [SIAM J. Numer. Anal., 45 (2007), pp. 2483--2509] and to the auxiliary space Maxwell solver AMS [J. Comput. Math., 27 (2009), pp. 604--623]. Finally, an extensive set of numerical experiments demonstrates the robustness and scalability of our implementation on large-scale $H(div)$ problems with large jumps in the material coefficients.

  7. Three-dimensional magnetotelluric inversion including topography using deformed hexahedral edge finite elements, direct solvers and data space Gauss-Newton, parallelized on SMP computers

    Science.gov (United States)

    Kordy, M. A.; Wannamaker, P. E.; Maris, V.; Cherkaev, E.; Hill, G. J.

    2014-12-01

    We have developed an algorithm for 3D simulation and inversion of magnetotelluric (MT) responses using deformable hexahedral finite elements that permits incorporation of topography. Direct solvers parallelized on symmetric multiprocessor (SMP), single-chassis workstations with large RAM are used for the forward solution, parameter jacobians, and model update. The forward simulator, jacobians calculations, as well as synthetic and real data inversion are presented. We use first-order edge elements to represent the secondary electric field (E), yielding accuracy O(h) for E and its curl (magnetic field). For very low frequency or small material admittivity, the E-field requires divergence correction. Using Hodge decomposition, correction may be applied after the forward solution is calculated. It allows accurate E-field solutions in dielectric air. The system matrix factorization is computed using the MUMPS library, which shows moderately good scalability through 12 processor cores but limited gains beyond that. The factored matrix is used to calculate the forward response as well as the jacobians of field and MT responses using the reciprocity theorem. Comparison with other codes demonstrates accuracy of our forward calculations. We consider a popular conductive/resistive double brick structure and several topographic models. In particular, the ability of finite elements to represent smooth topographic slopes permits accurate simulation of refraction of electromagnetic waves normal to the slopes at high frequencies. Run time tests indicate that for meshes as large as 150x150x60 elements, MT forward response and jacobians can be calculated in ~2.5 hours per frequency. For inversion, we implemented data space Gauss-Newton method, which offers reduction in memory requirement and a significant speedup of the parameter step versus model space approach. For dense matrix operations we use tiling approach of PLASMA library, which shows very good scalability. In synthetic

  8. Three-dimensional parallel edge-based finite element modeling of electromagnetic data with field redatuming

    DEFF Research Database (Denmark)

    Cai, Hongzhu; Čuma, Martin; Zhdanov, Michael

    2015-01-01

    This paper presents a parallelized version of the edge-based finite element method with a novel post-processing approach for numerical modeling of an electromagnetic field in complex media. The method uses an unstructured tetrahedral mesh which can reduce the number of degrees of freedom signific......This paper presents a parallelized version of the edge-based finite element method with a novel post-processing approach for numerical modeling of an electromagnetic field in complex media. The method uses an unstructured tetrahedral mesh which can reduce the number of degrees of freedom...... significantly. The linear system of finite element equations is solved using parallel direct solvers which are robust for ill-conditioned systems and efficient for multiple source electromagnetic (EM) modeling. We also introduce a novel approach to compute the scalar components of the electric field from...... the tangential components along each edge based on field redatuming. The method can produce a more accurate result as compared to conventional approach. We have applied the developed algorithm to compute the EM response for a typical 3D anisotropic geoelectrical model of the off-shore HC reservoir with complex...

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

    International Nuclear Information System (INIS)

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

    2017-01-01

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

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

    Energy Technology Data Exchange (ETDEWEB)

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

    2017-02-15

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

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

    KAUST Repository

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

    2015-01-01

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

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

    KAUST Repository

    Paszyńska, Anna

    2015-06-01

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

  13. A Finite Element Theory for Predicting the Attenuation of Extended-Reacting Liners

    Science.gov (United States)

    Watson, W. R.; Jones, M. G.

    2009-01-01

    A non-modal finite element theory for predicting the attenuation of an extended-reacting liner containing a porous facesheet and located in a no-flow duct is presented. The mathematical approach is to solve separate wave equations in the liner and duct airway and to couple these two solutions by invoking kinematic constraints at the facesheet that are consistent with a continuum theory of fluid motion. Given the liner intrinsic properties, a weak Galerkin finite element formulation with cubic polynomial basis functions is used as the basis for generating a discrete system of acoustic equations that are solved to obtain the coupled acoustic field. A state-of-the-art, asymmetric, parallel, sparse equation solver is implemented that allows tens of thousands of grid points to be analyzed. A grid refinement study is presented to show that the predicted attenuation converges. Excellent comparison of the numerically predicted attenuation to that of a mode theory (using a Haynes 25 metal foam liner) is used to validate the computational approach. Simulations are also presented for fifteen porous plate, extended-reacting liners. The construction of some of the porous plate liners suggest that they should behave as resonant liners while the construction of others suggest that they should behave as broadband attenuators. In each case the finite element theory is observed to predict the proper attenuation trend.

  14. Massively Parallel Finite Element Programming

    KAUST Repository

    Heister, Timo; Kronbichler, Martin; Bangerth, Wolfgang

    2010-01-01

    Today's large finite element simulations require parallel algorithms to scale on clusters with thousands or tens of thousands of processor cores. We present data structures and algorithms to take advantage of the power of high performance computers in generic finite element codes. Existing generic finite element libraries often restrict the parallelization to parallel linear algebra routines. This is a limiting factor when solving on more than a few hundreds of cores. We describe routines for distributed storage of all major components coupled with efficient, scalable algorithms. We give an overview of our effort to enable the modern and generic finite element library deal.II to take advantage of the power of large clusters. In particular, we describe the construction of a distributed mesh and develop algorithms to fully parallelize the finite element calculation. Numerical results demonstrate good scalability. © 2010 Springer-Verlag.

  15. Massively Parallel Finite Element Programming

    KAUST Repository

    Heister, Timo

    2010-01-01

    Today\\'s large finite element simulations require parallel algorithms to scale on clusters with thousands or tens of thousands of processor cores. We present data structures and algorithms to take advantage of the power of high performance computers in generic finite element codes. Existing generic finite element libraries often restrict the parallelization to parallel linear algebra routines. This is a limiting factor when solving on more than a few hundreds of cores. We describe routines for distributed storage of all major components coupled with efficient, scalable algorithms. We give an overview of our effort to enable the modern and generic finite element library deal.II to take advantage of the power of large clusters. In particular, we describe the construction of a distributed mesh and develop algorithms to fully parallelize the finite element calculation. Numerical results demonstrate good scalability. © 2010 Springer-Verlag.

  16. Large-Scale Parallel Finite Element Analysis of the Stress Singular Problems

    International Nuclear Information System (INIS)

    Noriyuki Kushida; Hiroshi Okuda; Genki Yagawa

    2002-01-01

    In this paper, the convergence behavior of large-scale parallel finite element method for the stress singular problems was investigated. The convergence behavior of iterative solvers depends on the efficiency of the pre-conditioners. However, efficiency of pre-conditioners may be influenced by the domain decomposition that is necessary for parallel FEM. In this study the following results were obtained: Conjugate gradient method without preconditioning and the diagonal scaling preconditioned conjugate gradient method were not influenced by the domain decomposition as expected. symmetric successive over relaxation method preconditioned conjugate gradient method converged 6% faster as maximum if the stress singular area was contained in one sub-domain. (authors)

  17. Modeling fragmentation with new high order finite element technology and node splitting

    Directory of Open Access Journals (Sweden)

    Olovsson Lars

    2015-01-01

    Full Text Available The modeling of fragmentation has historically been linked to the weapons industry where the main goal is to optimize a bomb or to design effective blast shields. Numerical modeling of fragmentation from dynamic loading has traditionally been modeled by legacy finite element solvers that rely on element erosion to model material failure. However this method results in the removal of too much material. This is not realistic as retaining the mass of the structure is critical to modeling the event correctly. We propose a new approach implemented in the IMPETUS AFEA SOLVER® based on the following: New High Order Finite Elements that can easily deal with very large deformations; Stochastic distribution of initial damage that allows for a non homogeneous distribution of fragments; and a Node Splitting Algorithm that allows for material fracture without element erosion that is mesh independent. The approach is evaluated for various materials and scenarios: -Titanium ring electromagnetic compression; Hard steel Taylor bar impact, Fused silica Taylor bar impact, Steel cylinder explosion, The results obtained from the simulations are representative of the failure mechanisms observed experimentally. The main benefit of this approach is good energy conservation (no loss of mass and numerical robustness even in complex situations.

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

  19. Finite element computational fluid mechanics

    International Nuclear Information System (INIS)

    Baker, A.J.

    1983-01-01

    This book analyzes finite element theory as applied to computational fluid mechanics. It includes a chapter on using the heat conduction equation to expose the essence of finite element theory, including higher-order accuracy and convergence in a common knowledge framework. Another chapter generalizes the algorithm to extend application to the nonlinearity of the Navier-Stokes equations. Other chapters are concerned with the analysis of a specific fluids mechanics problem class, including theory and applications. Some of the topics covered include finite element theory for linear mechanics; potential flow; weighted residuals/galerkin finite element theory; inviscid and convection dominated flows; boundary layers; parabolic three-dimensional flows; and viscous and rotational flows

  20. MINOS: A simplified Pn solver for core calculation

    International Nuclear Information System (INIS)

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

    2007-01-01

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

  1. Aleph Field Solver Challenge Problem Results Summary

    Energy Technology Data Exchange (ETDEWEB)

    Hooper, Russell [Sandia National Lab. (SNL-NM), Albuquerque, NM (United States); Moore, Stan Gerald [Sandia National Lab. (SNL-NM), Albuquerque, NM (United States)

    2015-01-01

    Aleph models continuum electrostatic and steady and transient thermal fields using a finite-element method. Much work has gone into expanding the core solver capability to support enriched modeling consisting of multiple interacting fields, special boundary conditions and two-way interfacial coupling with particles modeled using Aleph's complementary particle-in-cell capability. This report provides quantitative evidence for correct implementation of Aleph's field solver via order- of-convergence assessments on a collection of problems of increasing complexity. It is intended to provide Aleph with a pedigree and to establish a basis for confidence in results for more challenging problems important to Sandia's mission that Aleph was specifically designed to address.

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

    KAUST Repository

    Uysal, Ismail Enes

    2014-07-01

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

  3. Finite element modeling of electrically rectified piezoelectric energy harvesters

    International Nuclear Information System (INIS)

    Wu, P H; Shu, Y C

    2015-01-01

    Finite element models are developed for designing electrically rectified piezoelectric energy harvesters. They account for the consideration of common interface circuits such as the standard and parallel-/series-SSHI (synchronized switch harvesting on inductor) circuits, as well as complicated structural configurations such as arrays of piezoelectric oscillators. The idea is to replace the energy harvesting circuit by the proposed equivalent load impedance together with the capacitance of negative value. As a result, the proposed framework is capable of being implemented into conventional finite element solvers for direct system-level design without resorting to circuit simulators. The validation based on COMSOL simulations carried out for various interface circuits by the comparison with the standard modal analysis model. The framework is then applied to the investigation on how harvested power is reduced due to fabrication deviations in geometric and material properties of oscillators in an array system. Remarkably, it is found that for a standard array system with strong electromechanical coupling, the drop in peak power turns out to be insignificant if the optimal load is carefully chosen. The second application is to design broadband energy harvesting by developing array systems with suitable interface circuits. The result shows that significant broadband is observed for the parallel (series) connection of oscillators endowed with the parallel-SSHI (series-SSHI) circuit technique. (paper)

  4. Finite element modeling of electrically rectified piezoelectric energy harvesters

    Science.gov (United States)

    Wu, P. H.; Shu, Y. C.

    2015-09-01

    Finite element models are developed for designing electrically rectified piezoelectric energy harvesters. They account for the consideration of common interface circuits such as the standard and parallel-/series-SSHI (synchronized switch harvesting on inductor) circuits, as well as complicated structural configurations such as arrays of piezoelectric oscillators. The idea is to replace the energy harvesting circuit by the proposed equivalent load impedance together with the capacitance of negative value. As a result, the proposed framework is capable of being implemented into conventional finite element solvers for direct system-level design without resorting to circuit simulators. The validation based on COMSOL simulations carried out for various interface circuits by the comparison with the standard modal analysis model. The framework is then applied to the investigation on how harvested power is reduced due to fabrication deviations in geometric and material properties of oscillators in an array system. Remarkably, it is found that for a standard array system with strong electromechanical coupling, the drop in peak power turns out to be insignificant if the optimal load is carefully chosen. The second application is to design broadband energy harvesting by developing array systems with suitable interface circuits. The result shows that significant broadband is observed for the parallel (series) connection of oscillators endowed with the parallel-SSHI (series-SSHI) circuit technique.

  5. Finite elements and approximation

    CERN Document Server

    Zienkiewicz, O C

    2006-01-01

    A powerful tool for the approximate solution of differential equations, the finite element is extensively used in industry and research. This book offers students of engineering and physics a comprehensive view of the principles involved, with numerous illustrative examples and exercises.Starting with continuum boundary value problems and the need for numerical discretization, the text examines finite difference methods, weighted residual methods in the context of continuous trial functions, and piecewise defined trial functions and the finite element method. Additional topics include higher o

  6. A first course in finite elements

    CERN Document Server

    Fish, Jacob

    2007-01-01

    Developed from the authors, combined total of 50 years undergraduate and graduate teaching experience, this book presents the finite element method formulated as a general-purpose numerical procedure for solving engineering problems governed by partial differential equations.  Focusing on the formulation and application of the finite element method through the integration of finite element theory, code development, and software application, the book is both introductory and self-contained, as well as being a hands-on experience for any student. This authoritative text on Finite Elements:Adopts

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

    Energy Technology Data Exchange (ETDEWEB)

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

    2015-02-01

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

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

    International Nuclear Information System (INIS)

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

    2005-01-01

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

  9. Modelling optimization involving different types of elements in finite element analysis

    International Nuclear Information System (INIS)

    Wai, C M; Rivai, Ahmad; Bapokutty, Omar

    2013-01-01

    Finite elements are used to express the mechanical behaviour of a structure in finite element analysis. Therefore, the selection of the elements determines the quality of the analysis. The aim of this paper is to compare and contrast 1D element, 2D element, and 3D element used in finite element analysis. A simple case study was carried out on a standard W460x74 I-beam. The I-beam was modelled and analyzed statically with 1D elements, 2D elements and 3D elements. The results for the three separate finite element models were compared in terms of stresses, deformation and displacement of the I-beam. All three finite element models yield satisfactory results with acceptable errors. The advantages and limitations of these elements are discussed. 1D elements offer simplicity although lacking in their ability to model complicated geometry. 2D elements and 3D elements provide more detail yet sophisticated results which require more time and computer memory in the modelling process. It is also found that the choice of element in finite element analysis is influence by a few factors such as the geometry of the structure, desired analysis results, and the capability of the computer

  10. Grammar-Based Multi-Frontal Solver for One Dimensional Isogeometric Analysis with Multiple Right-Hand-Sides

    KAUST Repository

    Kuźnik, Krzysztof

    2013-06-01

    This paper introduces a grammar-based model for developing a multi-thread multi-frontal parallel direct solver for one- dimensional isogeometric finite element method. The model includes the integration of B-splines for construction of the element local matrices and the multi-frontal solver algorithm. The integration and the solver algorithm are partitioned into basic indivisible tasks, namely the grammar productions, that can be executed squentially. The partial order of execution of the basic tasks is analyzed to provide the scheduling for the execution of the concurrent integration and multi-frontal solver algo- rithm. This graph grammar analysis allows for optimal concurrent execution of all tasks. The model has been implemented and tested on NVIDIA CUDA GPU, delivering logarithmic execution time for linear, quadratic, cubic and higher order B-splines. Thus, the CUDA implementation delivers the optimal performance predicted by our graph grammar analysis. We utilize the solver for multiple right hand sides related to the solution of non-stationary or inverse problems.

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

    KAUST Repository

    Collier, Nathan

    2012-03-01

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

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

    KAUST Repository

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

    2012-01-01

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

  13. Simulations of singularity dynamics in liquid crystal flows: A C finite element approach

    International Nuclear Information System (INIS)

    Lin Ping; Liu Chun

    2006-01-01

    In this paper, we present a C finite element method for a 2a hydrodynamic liquid crystal model which is simpler than existing C 1 element methods and mixed element formulation. The energy law is formally justified and the energy decay is used as a validation tool for our numerical computation. A splitting method combined with only a few fixed point iteration for the penalty term of the director field is applied to reduce the size of the stiffness matrix and to keep the stiffness matrix time-independent. The latter avoids solving a linear system at every time step and largely reduces the computational time, especially when direct linear system solvers are used. Our approach is verified by comparing its computational results with those obtained by C 1 elements and by mixed formulation. Through numerical experiments of a few other splittings and explicit-implicit strategies, we recommend a fast and reliable algorithm for this model. A number of examples are computed to demonstrate the algorithm

  14. Non-linear finite element modeling

    DEFF Research Database (Denmark)

    Mikkelsen, Lars Pilgaard

    The note is written for courses in "Non-linear finite element method". The note has been used by the author teaching non-linear finite element modeling at Civil Engineering at Aalborg University, Computational Mechanics at Aalborg University Esbjerg, Structural Engineering at the University...

  15. Structural modeling techniques by finite element method

    International Nuclear Information System (INIS)

    Kang, Yeong Jin; Kim, Geung Hwan; Ju, Gwan Jeong

    1991-01-01

    This book includes introduction table of contents chapter 1 finite element idealization introduction summary of the finite element method equilibrium and compatibility in the finite element solution degrees of freedom symmetry and anti symmetry modeling guidelines local analysis example references chapter 2 static analysis structural geometry finite element models analysis procedure modeling guidelines references chapter 3 dynamic analysis models for dynamic analysis dynamic analysis procedures modeling guidelines and modeling guidelines.

  16. Solution of three-dimensional energy equation using finite element method

    International Nuclear Information System (INIS)

    Bhasin, V.; Singh, R.K.; Dutta, B.K.; Kushwaha, H.S.

    1993-01-01

    In the present work an attempt has been made to formulate an efficient 3-D finite element program for solving coupled momentum-energy equation with unsymmetric frontal solver and a suitable upwinding scheme. Based on the above solution technique of energy equation it can be concluded that upwinding scheme can lead to fairly accurate and smooth results even with coarse mesh. Otherwise the mesh size requirement will be extremely stringent for most of the practical problems. With upwinding the additional computer time required is marginally more. This effort has resulted in getting practical solution for large size real life problems in nuclear industry. The program was used for computation of temperature field in heavy water moderator of Madras Atomic Power Station (MAPS) reactor, in new mode of operation. (author). 9 refs., 7 figs

  17. A Matlab-based finite-difference solver for the Poisson problem with mixed Dirichlet-Neumann boundary conditions

    Science.gov (United States)

    Reimer, Ashton S.; Cheviakov, Alexei F.

    2013-03-01

    A Matlab-based finite-difference numerical solver for the Poisson equation for a rectangle and a disk in two dimensions, and a spherical domain in three dimensions, is presented. The solver is optimized for handling an arbitrary combination of Dirichlet and Neumann boundary conditions, and allows for full user control of mesh refinement. The solver routines utilize effective and parallelized sparse vector and matrix operations. Computations exhibit high speeds, numerical stability with respect to mesh size and mesh refinement, and acceptable error values even on desktop computers. Catalogue identifier: AENQ_v1_0 Program summary URL:http://cpc.cs.qub.ac.uk/summaries/AENQ_v1_0.html Program obtainable from: CPC Program Library, Queen's University, Belfast, N. Ireland Licensing provisions: GNU General Public License v3.0 No. of lines in distributed program, including test data, etc.: 102793 No. of bytes in distributed program, including test data, etc.: 369378 Distribution format: tar.gz Programming language: Matlab 2010a. Computer: PC, Macintosh. Operating system: Windows, OSX, Linux. RAM: 8 GB (8, 589, 934, 592 bytes) Classification: 4.3. Nature of problem: To solve the Poisson problem in a standard domain with “patchy surface”-type (strongly heterogeneous) Neumann/Dirichlet boundary conditions. Solution method: Finite difference with mesh refinement. Restrictions: Spherical domain in 3D; rectangular domain or a disk in 2D. Unusual features: Choice between mldivide/iterative solver for the solution of large system of linear algebraic equations that arise. Full user control of Neumann/Dirichlet boundary conditions and mesh refinement. Running time: Depending on the number of points taken and the geometry of the domain, the routine may take from less than a second to several hours to execute.

  18. Element-topology-independent preconditioners for parallel finite element computations

    Science.gov (United States)

    Park, K. C.; Alexander, Scott

    1992-01-01

    A family of preconditioners for the solution of finite element equations are presented, which are element-topology independent and thus can be applicable to element order-free parallel computations. A key feature of the present preconditioners is the repeated use of element connectivity matrices and their left and right inverses. The properties and performance of the present preconditioners are demonstrated via beam and two-dimensional finite element matrices for implicit time integration computations.

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

    KAUST Repository

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

    2015-01-01

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

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

    KAUST Repository

    Pavarino, L.F.

    2015-07-18

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

  1. On the Robustness and Prospects of Adaptive BDDC Methods for Finite Element Discretizations of Elliptic PDEs with High-Contrast Coefficients

    KAUST Repository

    Zampini, Stefano

    2016-06-02

    Balancing Domain Decomposition by Constraints (BDDC) methods have proven to be powerful preconditioners for large and sparse linear systems arising from the finite element discretization of elliptic PDEs. Condition number bounds can be theoretically established that are independent of the number of subdomains of the decomposition. The core of the methods resides in the design of a larger and partially discontinuous finite element space that allows for fast application of the preconditioner, where Cholesky factorizations of the subdomain finite element problems are additively combined with a coarse, global solver. Multilevel and highly-scalable algorithms can be obtained by replacing the coarse Cholesky solver with a coarse BDDC preconditioner. BDDC methods have the remarkable ability to control the condition number, since the coarse space of the preconditioner can be adaptively enriched at the cost of solving local eigenproblems. The proper identification of these eigenproblems extends the robustness of the methods to any heterogeneity in the distribution of the coefficients of the PDEs, not only when the coefficients jumps align with the subdomain boundaries or when the high contrast regions are confined to lie in the interior of the subdomains. The specific adaptive technique considered in this paper does not depend upon any interaction of discretization and partition; it relies purely on algebraic operations. Coarse space adaptation in BDDC methods has attractive algorithmic properties, since the technique enhances the concurrency and the arithmetic intensity of the preconditioning step of the sparse implicit solver with the aim of controlling the number of iterations of the Krylov method in a black-box fashion, thus reducing the number of global synchronization steps and matrix vector multiplications needed by the iterative solver; data movement and memory bound kernels in the solve phase can be thus limited at the expense of extra local ops during the setup of

  2. Probabilistic finite elements

    Science.gov (United States)

    Belytschko, Ted; Wing, Kam Liu

    1987-01-01

    In the Probabilistic Finite Element Method (PFEM), finite element methods have been efficiently combined with second-order perturbation techniques to provide an effective method for informing the designer of the range of response which is likely in a given problem. The designer must provide as input the statistical character of the input variables, such as yield strength, load magnitude, and Young's modulus, by specifying their mean values and their variances. The output then consists of the mean response and the variance in the response. Thus the designer is given a much broader picture of the predicted performance than with simply a single response curve. These methods are applicable to a wide class of problems, provided that the scale of randomness is not too large and the probabilistic density functions possess decaying tails. By incorporating the computational techniques we have developed in the past 3 years for efficiency, the probabilistic finite element methods are capable of handling large systems with many sources of uncertainties. Sample results for an elastic-plastic ten-bar structure and an elastic-plastic plane continuum with a circular hole subject to cyclic loadings with the yield stress on the random field are given.

  3. Finite element and finite difference methods in electromagnetic scattering

    CERN Document Server

    Morgan, MA

    2013-01-01

    This second volume in the Progress in Electromagnetic Research series examines recent advances in computational electromagnetics, with emphasis on scattering, as brought about by new formulations and algorithms which use finite element or finite difference techniques. Containing contributions by some of the world's leading experts, the papers thoroughly review and analyze this rapidly evolving area of computational electromagnetics. Covering topics ranging from the new finite-element based formulation for representing time-harmonic vector fields in 3-D inhomogeneous media using two coupled sca

  4. Electrical machine analysis using finite elements

    CERN Document Server

    Bianchi, Nicola

    2005-01-01

    OUTLINE OF ELECTROMAGNETIC FIELDSVector AnalysisElectromagnetic FieldsFundamental Equations SummaryReferencesBASIC PRINCIPLES OF FINITE ELEMENT METHODSIntroductionField Problems with Boundary ConditionsClassical Method for the Field Problem SolutionThe Classical Residual Method (Galerkin's Method)The Classical Variational Method (Rayleigh-Ritz's Method)The Finite Element MethodReferencesAPPLICATIONS OF THE FINITE ELEMENT METHOD TO TWO-DIMENSIONAL FIELDSIntroductionLinear Interpolation of the Function fApplication of the Variational MethodSimple Descriptions of Electromagnetic FieldsAppendix: I

  5. Effect of analysis parameters on non-linear implicit finite element analysis of marine corroded steel plate

    Science.gov (United States)

    Islam, Muhammad Rabiul; Sakib-Ul-Alam, Md.; Nazat, Kazi Kaarima; Hassan, M. Munir

    2017-12-01

    FEA results greatly depend on analysis parameters. MSC NASTRAN nonlinear implicit analysis code has been used in large deformation finite element analysis of pitted marine SM490A steel rectangular plate. The effect of two types actual pit shape on parameters of integrity of structure has been analyzed. For 3-D modeling, a proposed method for simulation of pitted surface by probabilistic corrosion model has been used. The result has been verified with the empirical formula proposed by finite element analysis of steel surface generated with different pitted data where analyses have been carried out by the code of LS-DYNA 971. In the both solver, an elasto-plastic material has been used where an arbitrary stress versus strain curve can be defined. In the later one, the material model is based on the J2 flow theory with isotropic hardening where a radial return algorithm is used. The comparison shows good agreement between the two results which ensures successful simulation with comparatively less energy and time.

  6. Development of polygon elements based on the scaled boundary finite element method

    International Nuclear Information System (INIS)

    Chiong, Irene; Song Chongmin

    2010-01-01

    We aim to extend the scaled boundary finite element method to construct conforming polygon elements. The development of the polygonal finite element is highly anticipated in computational mechanics as greater flexibility and accuracy can be achieved using these elements. The scaled boundary polygonal finite element will enable new developments in mesh generation, better accuracy from a higher order approximation and better transition elements in finite element meshes. Polygon elements of arbitrary number of edges and order have been developed successfully. The edges of an element are discretised with line elements. The displacement solution of the scaled boundary finite element method is used in the development of shape functions. They are shown to be smooth and continuous within the element, and satisfy compatibility and completeness requirements. Furthermore, eigenvalue decomposition has been used to depict element modes and outcomes indicate the ability of the scaled boundary polygonal element to express rigid body and constant strain modes. Numerical tests are presented; the patch test is passed and constant strain modes verified. Accuracy and convergence of the method are also presented and the performance of the scaled boundary polygonal finite element is verified on Cook's swept panel problem. Results show that the scaled boundary polygonal finite element method outperforms a traditional mesh and accuracy and convergence are achieved from fewer nodes. The proposed method is also shown to be truly flexible, and applies to arbitrary n-gons formed of irregular and non-convex polygons.

  7. IGA-ADS: Isogeometric analysis FEM using ADS solver

    Science.gov (United States)

    Łoś, Marcin M.; Woźniak, Maciej; Paszyński, Maciej; Lenharth, Andrew; Hassaan, Muhamm Amber; Pingali, Keshav

    2017-08-01

    In this paper we present a fast explicit solver for solution of non-stationary problems using L2 projections with isogeometric finite element method. The solver has been implemented within GALOIS framework. It enables parallel multi-core simulations of different time-dependent problems, in 1D, 2D, or 3D. We have prepared the solver framework in a way that enables direct implementation of the selected PDE and corresponding boundary conditions. In this paper we describe the installation, implementation of exemplary three PDEs, and execution of the simulations on multi-core Linux cluster nodes. We consider three case studies, including heat transfer, linear elasticity, as well as non-linear flow in heterogeneous media. The presented package generates output suitable for interfacing with Gnuplot and ParaView visualization software. The exemplary simulations show near perfect scalability on Gilbert shared-memory node with four Intel® Xeon® CPU E7-4860 processors, each possessing 10 physical cores (for a total of 40 cores).

  8. Optimising a parallel conjugate gradient solver

    Energy Technology Data Exchange (ETDEWEB)

    Field, M.R. [O`Reilly Institute, Dublin (Ireland)

    1996-12-31

    This work arises from the introduction of a parallel iterative solver to a large structural analysis finite element code. The code is called FEX and it was developed at Hitachi`s Mechanical Engineering Laboratory. The FEX package can deal with a large range of structural analysis problems using a large number of finite element techniques. FEX can solve either stress or thermal analysis problems of a range of different types from plane stress to a full three-dimensional model. These problems can consist of a number of different materials which can be modelled by a range of material models. The structure being modelled can have the load applied at either a point or a surface, or by a pressure, a centrifugal force or just gravity. Alternatively a thermal load can be applied with a given initial temperature. The displacement of the structure can be constrained by having a fixed boundary or by prescribing the displacement at a boundary.

  9. Finite element analysis of prestressed concrete reactor vessels

    International Nuclear Information System (INIS)

    Smith, P.D.; Cook, W.A.; Anderson, C.A.

    1977-01-01

    This paper discusses the development of a finite element code suitable for the safety analysis of prestressed concrete reactor vessels. The project has involved modification of a general purpose computer code to handle reinforced concrete structures as well as comparison of results obtained with the code against published experimental data. The NONSAP nonlinear structural analysis program was selected for the ease with which it can be modified to encompass problems peculiar to nuclear reactors. Pre- and post-processors have been developed for mesh generation and for graphical display of response variables. An out-of-core assembler and solver have been developed for the analysis of large three dimensional problems. The constitutive model for short term loads forms an orthotropic stress-strain relationship in which the concrete and the reinforcing steel are treated as a composite. The variation of stiffness and strength of concrete under multiaxial stress states is accounted for. Cracks are allowed to form at element integration points based on a three dimensional failure envelope in stress space. Composite tensile and shear properties across a crack are modified to account for bond degradation and for dowel action of the reinforcement. The constitutive law for creep is base on the expansion of the usual creep compliance function in the form of a Dirichlet exponential series. Empirical creep data are then fit to the Dirichlet series approximation by means of a least squares procedure. The incremental deformation process is subsequently reduced to a series of variable stiffness elasticity problems in which the past stress history is represented by a finite number of hidden material variables

  10. A Numerical Study of Scalable Cardiac Electro-Mechanical Solvers on HPC Architectures

    Directory of Open Access Journals (Sweden)

    Piero Colli Franzone

    2018-04-01

    Full Text Available We introduce and study some scalable domain decomposition preconditioners for cardiac electro-mechanical 3D simulations on parallel HPC (High Performance Computing architectures. The electro-mechanical model of the cardiac tissue is composed of four coupled sub-models: (1 the static finite elasticity equations for the transversely isotropic deformation of the cardiac tissue; (2 the active tension model describing the dynamics of the intracellular calcium, cross-bridge binding and myofilament tension; (3 the anisotropic Bidomain model describing the evolution of the intra- and extra-cellular potentials in the deforming cardiac tissue; and (4 the ionic membrane model describing the dynamics of ionic currents, gating variables, ionic concentrations and stretch-activated channels. This strongly coupled electro-mechanical model is discretized in time with a splitting semi-implicit technique and in space with isoparametric finite elements. The resulting scalable parallel solver is based on Multilevel Additive Schwarz preconditioners for the solution of the Bidomain system and on BDDC preconditioned Newton-Krylov solvers for the non-linear finite elasticity system. The results of several 3D parallel simulations show the scalability of both linear and non-linear solvers and their application to the study of both physiological excitation-contraction cardiac dynamics and re-entrant waves in the presence of different mechano-electrical feedbacks.

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

  12. FINITE ELEMENT MODEL FOR PREDICTING RESIDUAL ...

    African Journals Online (AJOL)

    FINITE ELEMENT MODEL FOR PREDICTING RESIDUAL STRESSES IN ... the transverse residual stress in the x-direction (σx) had a maximum value of 375MPa ... the finite element method are in fair agreement with the experimental results.

  13. Finite element methods a practical guide

    CERN Document Server

    Whiteley, Jonathan

    2017-01-01

    This book presents practical applications of the finite element method to general differential equations. The underlying strategy of deriving the finite element solution is introduced using linear ordinary differential equations, thus allowing the basic concepts of the finite element solution to be introduced without being obscured by the additional mathematical detail required when applying this technique to partial differential equations. The author generalizes the presented approach to partial differential equations which include nonlinearities. The book also includes variations of the finite element method such as different classes of meshes and basic functions. Practical application of the theory is emphasised, with development of all concepts leading ultimately to a description of their computational implementation illustrated using Matlab functions. The target audience primarily comprises applied researchers and practitioners in engineering, but the book may also be beneficial for graduate students.

  14. Finite element analysis of piezoelectric materials

    International Nuclear Information System (INIS)

    Lowrie, F.; Stewart, M.; Cain, M.; Gee, M.

    1999-01-01

    This guide is intended to help people wanting to do finite element analysis of piezoelectric materials by answering some of the questions that are peculiar to piezoelectric materials. The document is not intended as a complete beginners guide for finite element analysis in general as this is better dealt with by the individual software producers. The guide is based around the commercial package ANSYS as this is a popular package amongst piezoelectric material users, however much of the information will still be useful to users of other finite element codes. (author)

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

    Science.gov (United States)

    Burtyka, Filipp

    2018-03-01

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

  16. Finite rotation shells basic equations and finite elements for Reissner kinematics

    CERN Document Server

    Wisniewski, K

    2010-01-01

    This book covers theoretical and computational aspects of non-linear shells. Several advanced topics of shell equations and finite elements - not included in standard textbooks on finite elements - are addressed, and the book includes an extensive bibliography.

  17. Impact of element-level static condensation on iterative solver performance

    KAUST Repository

    Pardo, D.

    2015-10-02

    This paper provides theoretical estimates that quantify and clarify the savings associated to the use of element-level static condensation as a first step of an iterative solver. These estimates are verified numerically. The numerical evidence shows that static condensation at the element level is beneficial for higher-order methods. For lower-order methods or when the number of iterations required for convergence is low, the setup cost of the elimination as well as its implementation may offset the benefits obtained during the iteration process. However, as the iteration count (e.g., above 50) or the polynomial order (e.g., above cubics) grows, the benefits of element-level static condensation are significant.

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

    Science.gov (United States)

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

    2010-06-21

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

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

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

    NARCIS (Netherlands)

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

    2003-01-01

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

  1. Domain decomposition methods for mortar finite elements

    Energy Technology Data Exchange (ETDEWEB)

    Widlund, O.

    1996-12-31

    In the last few years, domain decomposition methods, previously developed and tested for standard finite element methods and elliptic problems, have been extended and modified to work for mortar and other nonconforming finite element methods. A survey will be given of work carried out jointly with Yves Achdou, Mario Casarin, Maksymilian Dryja and Yvon Maday. Results on the p- and h-p-version finite elements will also be discussed.

  2. Why do probabilistic finite element analysis ?

    CERN Document Server

    Thacker, Ben H

    2008-01-01

    The intention of this book is to provide an introduction to performing probabilistic finite element analysis. As a short guideline, the objective is to inform the reader of the use, benefits and issues associated with performing probabilistic finite element analysis without excessive theory or mathematical detail.

  3. An efficient finite element solution for gear dynamics

    International Nuclear Information System (INIS)

    Cooley, C G; Parker, R G; Vijayakar, S M

    2010-01-01

    A finite element formulation for the dynamic response of gear pairs is proposed. Following an established approach in lumped parameter gear dynamic models, the static solution is used as the excitation in a frequency domain solution of the finite element vibration model. The nonlinear finite element/contact mechanics formulation provides accurate calculation of the static solution and average mesh stiffness that are used in the dynamic simulation. The frequency domain finite element calculation of dynamic response compares well with numerically integrated (time domain) finite element dynamic results and previously published experimental results. Simulation time with the proposed formulation is two orders of magnitude lower than numerically integrated dynamic results. This formulation admits system level dynamic gearbox response, which may include multiple gear meshes, flexible shafts, rolling element bearings, housing structures, and other deformable components.

  4. Finite element analysis theory and application with ANSYS

    CERN Document Server

    Moaveni, Saeed

    2015-01-01

    For courses in Finite Element Analysis, offered in departments of Mechanical or Civil and Environmental Engineering. While many good textbooks cover the theory of finite element modeling, Finite Element Analysis: Theory and Application with ANSYS is the only text available that incorporates ANSYS as an integral part of its content. Moaveni presents the theory of finite element analysis, explores its application as a design/modeling tool, and explains in detail how to use ANSYS intelligently and effectively. Teaching and Learning Experience This program will provide a better teaching and learning experience-for you and your students. It will help: *Present the Theory of Finite Element Analysis: The presentation of theoretical aspects of finite element analysis is carefully designed not to overwhelm students. *Explain How to Use ANSYS Effectively: ANSYS is incorporated as an integral part of the content throughout the book. *Explore How to Use FEA as a Design/Modeling Tool: Open-ended design problems help stude...

  5. Finite element application to global reactor analysis

    International Nuclear Information System (INIS)

    Schmidt, F.A.R.

    1981-01-01

    The Finite Element Method is described as a Coarse Mesh Method with general basis and trial functions. Various consequences concerning programming and application of Finite Element Methods in reactor physics are drawn. One of the conclusions is that the Finite Element Method is a valuable tool in solving global reactor analysis problems. However, problems which can be described by rectangular boxes still can be solved with special coarse mesh programs more efficiently. (orig.) [de

  6. Finite-Element Software for Conceptual Design

    DEFF Research Database (Denmark)

    Lindemann, J.; Sandberg, G.; Damkilde, Lars

    2010-01-01

    and research. Forcepad is an effort to provide a conceptual design and teaching tool in a finite-element software package. Forcepad is a two-dimensional finite-element application based on the same conceptual model as image editing applications such as Adobe Photoshop or Microsoft Paint. Instead of using...

  7. Books and monographs on finite element technology

    Science.gov (United States)

    Noor, A. K.

    1985-01-01

    The present paper proviees a listing of all of the English books and some of the foreign books on finite element technology, taking into account also a list of the conference proceedings devoted solely to finite elements. The references are divided into categories. Attention is given to fundamentals, mathematical foundations, structural and solid mechanics applications, fluid mechanics applications, other applied science and engineering applications, computer implementation and software systems, computational and modeling aspects, special topics, boundary element methods, proceedings of symmposia and conferences on finite element technology, bibliographies, handbooks, and historical accounts.

  8. The value of continuity: Refined isogeometric analysis and fast direct solvers

    KAUST Repository

    Garcia, Daniel

    2016-08-26

    We propose the use of highly continuous finite element spaces interconnected with low continuity hyperplanes to maximize the performance of direct solvers. Starting from a highly continuous Isogeometric Analysis (IGA) discretization, we introduce . C0-separators to reduce the interconnection between degrees of freedom in the mesh. By doing so, both the solution time and best approximation errors are simultaneously improved. We call the resulting method

  9. The value of continuity: Refined isogeometric analysis and fast direct solvers

    KAUST Repository

    Garcia, Daniel; Pardo, David; Dalcin, Lisandro; Paszyński, Maciej; Collier, Nathan; Calo, Victor M.

    2016-01-01

    We propose the use of highly continuous finite element spaces interconnected with low continuity hyperplanes to maximize the performance of direct solvers. Starting from a highly continuous Isogeometric Analysis (IGA) discretization, we introduce . C0-separators to reduce the interconnection between degrees of freedom in the mesh. By doing so, both the solution time and best approximation errors are simultaneously improved. We call the resulting method

  10. 3-dimensional magnetotelluric inversion including topography using deformed hexahedral edge finite elements and direct solvers parallelized on symmetric multiprocessor computers - Part II: direct data-space inverse solution

    Science.gov (United States)

    Kordy, M.; Wannamaker, P.; Maris, V.; Cherkaev, E.; Hill, G.

    2016-01-01

    Following the creation described in Part I of a deformable edge finite-element simulator for 3-D magnetotelluric (MT) responses using direct solvers, in Part II we develop an algorithm named HexMT for 3-D regularized inversion of MT data including topography. Direct solvers parallelized on large-RAM, symmetric multiprocessor (SMP) workstations are used also for the Gauss-Newton model update. By exploiting the data-space approach, the computational cost of the model update becomes much less in both time and computer memory than the cost of the forward simulation. In order to regularize using the second norm of the gradient, we factor the matrix related to the regularization term and apply its inverse to the Jacobian, which is done using the MKL PARDISO library. For dense matrix multiplication and factorization related to the model update, we use the PLASMA library which shows very good scalability across processor cores. A synthetic test inversion using a simple hill model shows that including topography can be important; in this case depression of the electric field by the hill can cause false conductors at depth or mask the presence of resistive structure. With a simple model of two buried bricks, a uniform spatial weighting for the norm of model smoothing recovered more accurate locations for the tomographic images compared to weightings which were a function of parameter Jacobians. We implement joint inversion for static distortion matrices tested using the Dublin secret model 2, for which we are able to reduce nRMS to ˜1.1 while avoiding oscillatory convergence. Finally we test the code on field data by inverting full impedance and tipper MT responses collected around Mount St Helens in the Cascade volcanic chain. Among several prominent structures, the north-south trending, eruption-controlling shear zone is clearly imaged in the inversion.

  11. Probabilistic finite elements for fracture mechanics

    Science.gov (United States)

    Besterfield, Glen

    1988-01-01

    The probabilistic finite element method (PFEM) is developed for probabilistic fracture mechanics (PFM). A finite element which has the near crack-tip singular strain embedded in the element is used. Probabilistic distributions, such as expectation, covariance and correlation stress intensity factors, are calculated for random load, random material and random crack length. The method is computationally quite efficient and can be expected to determine the probability of fracture or reliability.

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

    Science.gov (United States)

    Ghil, M.; Balgovind, R.

    1979-01-01

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

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

  14. Introduction to finite and spectral element methods using Matlab

    CERN Document Server

    Pozrikidis, Constantine

    2014-01-01

    The Finite Element Method in One Dimension. Further Applications in One Dimension. High-Order and Spectral Elements in One Dimension. The Finite Element Method in Two Dimensions. Quadratic and Spectral Elements in Two Dimensions. Applications in Mechanics. Viscous Flow. Finite and Spectral Element Methods in Three Dimensions. Appendices. References. Index.

  15. Comparison of finite element and fast Fourier transform crystal plasticity solvers for texture prediction

    International Nuclear Information System (INIS)

    Liu, B; Raabe, D; Roters, F; Eisenlohr, P; Lebensohn, R A

    2010-01-01

    We compare two full-field formulations, i.e. a crystal plasticity fast Fourier transform-based (CPFFT) model and the crystal plasticity finite element model (CPFEM) in terms of the deformation textures predicted by both approaches. Plane-strain compression of a 1024-grain ensemble is simulated with CPFFT and CPFEM to assess the models in terms of their predictions of texture evolution for engineering applications. Different combinations of final textures and strain distributions are obtained with the CPFFT and CPFEM models for this 1024-grain polycrystal. To further understand these different predictions, the correlation between grain rotations and strain gradients is investigated through the simulation of plane-strain compression of bicrystals. Finally, a study of the influence of the initial crystal orientation and the crystallographic neighborhood on grain rotations and grain subdivisions is carried out by means of plane-strain compression simulations of a 64-grain cluster

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

    International Nuclear Information System (INIS)

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

    2003-01-01

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

  17. Finite Element Methods and Their Applications

    CERN Document Server

    Chen, Zhangxin

    2005-01-01

    This book serves as a text for one- or two-semester courses for upper-level undergraduates and beginning graduate students and as a professional reference for people who want to solve partial differential equations (PDEs) using finite element methods. The author has attempted to introduce every concept in the simplest possible setting and maintain a level of treatment that is as rigorous as possible without being unnecessarily abstract. Quite a lot of attention is given to discontinuous finite elements, characteristic finite elements, and to the applications in fluid and solid mechanics including applications to porous media flow, and applications to semiconductor modeling. An extensive set of exercises and references in each chapter are provided.

  18. Programming the finite element method

    CERN Document Server

    Smith, I M; Margetts, L

    2013-01-01

    Many students, engineers, scientists and researchers have benefited from the practical, programming-oriented style of the previous editions of Programming the Finite Element Method, learning how to develop computer programs to solve specific engineering problems using the finite element method. This new fifth edition offers timely revisions that include programs and subroutine libraries fully updated to Fortran 2003, which are freely available online, and provides updated material on advances in parallel computing, thermal stress analysis, plasticity return algorithms, convection boundary c

  19. Implementation of the Vanka-type multigrid solver for the finite element approximation of the Navier-Stokes equations on GPU

    Czech Academy of Sciences Publication Activity Database

    Bauer, Petr; Klement, V.; Oberhuber, T.; Žabka, V.

    2016-01-01

    Roč. 200, March (2016), s. 50-56 ISSN 0010-4655 R&D Projects: GA ČR GB14-36566G Institutional support: RVO:61388998 Keywords : Navier–Stokes equations * mixed finite elements * multigrid * Vanka-type smoothers * Gauss–Seidel * red–black coloring * parallelization * GPU Subject RIV: BK - Fluid Dynamics Impact factor: 3.936, year: 2016

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

    Energy Technology Data Exchange (ETDEWEB)

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

    2011-07-01

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

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

    International Nuclear Information System (INIS)

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

    2011-01-01

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

  2. Mixed Element Formulation for the Finite Element-Boundary Integral Method

    National Research Council Canada - National Science Library

    Meese, J; Kempel, L. C; Schneider, S. W

    2006-01-01

    A mixed element approach using right hexahedral elements and right prism elements for the finite element-boundary integral method is presented and discussed for the study of planar cavity-backed antennas...

  3. True Concurrent Thermal Engineering Integrating CAD Model Building with Finite Element and Finite Difference Methods

    Science.gov (United States)

    Panczak, Tim; Ring, Steve; Welch, Mark

    1999-01-01

    Thermal engineering has long been left out of the concurrent engineering environment dominated by CAD (computer aided design) and FEM (finite element method) software. Current tools attempt to force the thermal design process into an environment primarily created to support structural analysis, which results in inappropriate thermal models. As a result, many thermal engineers either build models "by hand" or use geometric user interfaces that are separate from and have little useful connection, if any, to CAD and FEM systems. This paper describes the development of a new thermal design environment called the Thermal Desktop. This system, while fully integrated into a neutral, low cost CAD system, and which utilizes both FEM and FD methods, does not compromise the needs of the thermal engineer. Rather, the features needed for concurrent thermal analysis are specifically addressed by combining traditional parametric surface based radiation and FD based conduction modeling with CAD and FEM methods. The use of flexible and familiar temperature solvers such as SINDA/FLUINT (Systems Improved Numerical Differencing Analyzer/Fluid Integrator) is retained.

  4. FINITE ELEMENT ANALYSIS OF STRUCTURES

    Directory of Open Access Journals (Sweden)

    PECINGINA OLIMPIA-MIOARA

    2015-05-01

    Full Text Available The application of finite element method is analytical when solutions can not be applied for deeper study analyzes static, dynamic or other types of requirements in different points of the structures .In practice it is necessary to know the behavior of the structure or certain parts components of the machine under the influence of certain factors static and dynamic . The application of finite element in the optimization of components leads to economic growth , to increase reliability and durability organs studied, thus the machine itself.

  5. Surgery simulation using fast finite elements

    DEFF Research Database (Denmark)

    Bro-Nielsen, Morten

    1996-01-01

    This paper describes our recent work on real-time surgery simulation using fast finite element models of linear elasticity. In addition, we discuss various improvements in terms of speed and realism......This paper describes our recent work on real-time surgery simulation using fast finite element models of linear elasticity. In addition, we discuss various improvements in terms of speed and realism...

  6. Using Finite Element Method

    Directory of Open Access Journals (Sweden)

    M.H.R. Ghoreishy

    2008-02-01

    Full Text Available This research work is devoted to the footprint analysis of a steel-belted radial tyre (185/65R14 under vertical static load using finite element method. Two models have been developed in which in the first model the tread patterns were replaced by simple ribs while the second model was consisted of details of the tread blocks. Linear elastic and hyper elastic (Arruda-Boyce material models were selected to describe the mechanical behavior of the reinforcing and rubbery parts, respectively. The above two finite element models of the tyre were analyzed under inflation pressure and vertical static loads. The second model (with detailed tread patterns was analyzed with and without friction effect between tread and contact surfaces. In every stage of the analysis, the results were compared with the experimental data to confirm the accuracy and applicability of the model. Results showed that neglecting the tread pattern design not only reduces the computational cost and effort but also the differences between computed deformations do not show significant changes. However, more complicated variables such as shape and area of the footprint zone and contact pressure are affected considerably by the finite element model selected for the tread blocks. In addition, inclusion of friction even in static state changes these variables significantly.

  7. Precise magnetostatic field using the finite element method

    International Nuclear Information System (INIS)

    Nascimento, Francisco Rogerio Teixeira do

    2013-01-01

    The main objective of this work is to simulate electromagnetic fields using the Finite Element Method. Even in the easiest case of electrostatic and magnetostatic numerical simulation some problems appear when the nodal finite element is used. It is difficult to model vector fields with scalar functions mainly in non-homogeneous materials. With the aim to solve these problems two types of techniques are tried: the adaptive remeshing using nodal elements and the edge finite element that ensure the continuity of tangential components. Some numerical analysis of simple electromagnetic problems with homogeneous and non-homogeneous materials are performed using first, the adaptive remeshing based in various error indicators and second, the numerical solution of waveguides using edge finite element. (author)

  8. Finite-element time-domain modeling of electromagnetic data in general dispersive medium using adaptive Padé series

    Science.gov (United States)

    Cai, Hongzhu; Hu, Xiangyun; Xiong, Bin; Zhdanov, Michael S.

    2017-12-01

    The induced polarization (IP) method has been widely used in geophysical exploration to identify the chargeable targets such as mineral deposits. The inversion of the IP data requires modeling the IP response of 3D dispersive conductive structures. We have developed an edge-based finite-element time-domain (FETD) modeling method to simulate the electromagnetic (EM) fields in 3D dispersive medium. We solve the vector Helmholtz equation for total electric field using the edge-based finite-element method with an unstructured tetrahedral mesh. We adopt the backward propagation Euler method, which is unconditionally stable, with semi-adaptive time stepping for the time domain discretization. We use the direct solver based on a sparse LU decomposition to solve the system of equations. We consider the Cole-Cole model in order to take into account the frequency-dependent conductivity dispersion. The Cole-Cole conductivity model in frequency domain is expanded using a truncated Padé series with adaptive selection of the center frequency of the series for early and late time. This approach can significantly increase the accuracy of FETD modeling.

  9. Relativistic extension of a charge-conservative finite element solver for time-dependent Maxwell-Vlasov equations

    Science.gov (United States)

    Na, D.-Y.; Moon, H.; Omelchenko, Y. A.; Teixeira, F. L.

    2018-01-01

    Accurate modeling of relativistic particle motion is essential for physical predictions in many problems involving vacuum electronic devices, particle accelerators, and relativistic plasmas. A local, explicit, and charge-conserving finite-element time-domain (FETD) particle-in-cell (PIC) algorithm for time-dependent (non-relativistic) Maxwell-Vlasov equations on irregular (unstructured) meshes was recently developed by Moon et al. [Comput. Phys. Commun. 194, 43 (2015); IEEE Trans. Plasma Sci. 44, 1353 (2016)]. Here, we extend this FETD-PIC algorithm to the relativistic regime by implementing and comparing three relativistic particle-pushers: (relativistic) Boris, Vay, and Higuera-Cary. We illustrate the application of the proposed relativistic FETD-PIC algorithm for the analysis of particle cyclotron motion at relativistic speeds, harmonic particle oscillation in the Lorentz-boosted frame, and relativistic Bernstein modes in magnetized charge-neutral (pair) plasmas.

  10. Controlling the numerical Cerenkov instability in PIC simulations using a customized finite difference Maxwell solver and a local FFT based current correction

    International Nuclear Information System (INIS)

    Li, Fei; Yu, Peicheng; Xu, Xinlu; Fiuza, Frederico; Decyk, Viktor K.

    2017-01-01

    In this study we present a customized finite-difference-time-domain (FDTD) Maxwell solver for the particle-in-cell (PIC) algorithm. The solver is customized to effectively eliminate the numerical Cerenkov instability (NCI) which arises when a plasma (neutral or non-neutral) relativistically drifts on a grid when using the PIC algorithm. We control the EM dispersion curve in the direction of the plasma drift of a FDTD Maxwell solver by using a customized higher order finite difference operator for the spatial derivative along the direction of the drift (1^ direction). We show that this eliminates the main NCI modes with moderate |k_1|, while keeps additional main NCI modes well outside the range of physical interest with higher |k_1|. These main NCI modes can be easily filtered out along with first spatial aliasing NCI modes which are also at the edge of the fundamental Brillouin zone. The customized solver has the possible advantage of improved parallel scalability because it can be easily partitioned along 1^ which typically has many more cells than other directions for the problems of interest. We show that FFTs can be performed locally to current on each partition to filter out the main and first spatial aliasing NCI modes, and to correct the current so that it satisfies the continuity equation for the customized spatial derivative. This ensures that Gauss’ Law is satisfied. Lastly, we present simulation examples of one relativistically drifting plasma, of two colliding relativistically drifting plasmas, and of nonlinear laser wakefield acceleration (LWFA) in a Lorentz boosted frame that show no evidence of the NCI can be observed when using this customized Maxwell solver together with its NCI elimination scheme.

  11. ANSYS mechanical APDL for finite element analysis

    CERN Document Server

    Thompson, Mary Kathryn

    2017-01-01

    ANSYS Mechanical APDL for Finite Element Analysis provides a hands-on introduction to engineering analysis using one of the most powerful commercial general purposes finite element programs on the market. Students will find a practical and integrated approach that combines finite element theory with best practices for developing, verifying, validating and interpreting the results of finite element models, while engineering professionals will appreciate the deep insight presented on the program's structure and behavior. Additional topics covered include an introduction to commands, input files, batch processing, and other advanced features in ANSYS. The book is written in a lecture/lab style, and each topic is supported by examples, exercises and suggestions for additional readings in the program documentation. Exercises gradually increase in difficulty and complexity, helping readers quickly gain confidence to independently use the program. This provides a solid foundation on which to build, preparing readers...

  12. Finite elements of nonlinear continua

    CERN Document Server

    Oden, John Tinsley

    1972-01-01

    Geared toward undergraduate and graduate students, this text extends applications of the finite element method from linear problems in elastic structures to a broad class of practical, nonlinear problems in continuum mechanics. It treats both theory and applications from a general and unifying point of view.The text reviews the thermomechanical principles of continuous media and the properties of the finite element method, and then brings them together to produce discrete physical models of nonlinear continua. The mathematical properties of these models are analyzed, along with the numerical s

  13. Design of a Modular Monolithic Implicit Solver for Multi-Physics Applications

    Science.gov (United States)

    Carton De Wiart, Corentin; Diosady, Laslo T.; Garai, Anirban; Burgess, Nicholas; Blonigan, Patrick; Ekelschot, Dirk; Murman, Scott M.

    2018-01-01

    The design of a modular multi-physics high-order space-time finite-element framework is presented together with its extension to allow monolithic coupling of different physics. One of the main objectives of the framework is to perform efficient high- fidelity simulations of capsule/parachute systems. This problem requires simulating multiple physics including, but not limited to, the compressible Navier-Stokes equations, the dynamics of a moving body with mesh deformations and adaptation, the linear shell equations, non-re effective boundary conditions and wall modeling. The solver is based on high-order space-time - finite element methods. Continuous, discontinuous and C1-discontinuous Galerkin methods are implemented, allowing one to discretize various physical models. Tangent and adjoint sensitivity analysis are also targeted in order to conduct gradient-based optimization, error estimation, mesh adaptation, and flow control, adding another layer of complexity to the framework. The decisions made to tackle these challenges are presented. The discussion focuses first on the "single-physics" solver and later on its extension to the monolithic coupling of different physics. The implementation of different physics modules, relevant to the capsule/parachute system, are also presented. Finally, examples of coupled computations are presented, paving the way to the simulation of the full capsule/parachute system.

  14. Finite element modelling and analysis of composites toecaps

    International Nuclear Information System (INIS)

    Yang, C C; Duhovic, M; Lin, R J T; Bhattacharyya, D

    2009-01-01

    Composite toe-caps have attracted considerable attention due to their advantageous properties over traditional metallic toe-caps. However, the anisotropic properties of composite materials also make the toe-cap performance more complex to analyse. This project aims at developing a Finite Element (FE) model for composite toe-caps with the aid of compression testing data. The geometry of the toe-cap was first scanned and imported into an FEA software package to create a workable FE model. The method was then validated by comparing the FE model with experimental results of steel toe-caps. Manufacturing, modelling and testing of custom-made composite toe-cap samples were then carried out. Modelling outputs of composite toe-caps were compared with compression test data for validation. The stress distributions and deformations of the toe-caps were also analysed. Modelling of the steel and composite toe-caps was realized using LS-DYNA Solver and PrePost (registered) . All FE analyses were modelled with reference to European Standards. The developed FE models can in the future be used to model toe-caps with various materials to determine the effects of fibre orientation relating to structural strength, and to achieve structural optimisation.

  15. Automating the generation of finite element dynamical cores with Firedrake

    Science.gov (United States)

    Ham, David; Mitchell, Lawrence; Homolya, Miklós; Luporini, Fabio; Gibson, Thomas; Kelly, Paul; Cotter, Colin; Lange, Michael; Kramer, Stephan; Shipton, Jemma; Yamazaki, Hiroe; Paganini, Alberto; Kärnä, Tuomas

    2017-04-01

    The development of a dynamical core is an increasingly complex software engineering undertaking. As the equations become more complete, the discretisations more sophisticated and the hardware acquires ever more fine-grained parallelism and deeper memory hierarchies, the problem of building, testing and modifying dynamical cores becomes increasingly complex. Here we present Firedrake, a code generation system for the finite element method with specialist features designed to support the creation of geoscientific models. Using Firedrake, the dynamical core developer writes the partial differential equations in weak form in a high level mathematical notation. Appropriate function spaces are chosen and time stepping loops written at the same high level. When the programme is run, Firedrake generates high performance C code for the resulting numerics which are executed in parallel. Models in Firedrake typically take a tiny fraction of the lines of code required by traditional hand-coding techniques. They support more sophisticated numerics than are easily achieved by hand, and the resulting code is frequently higher performance. Critically, debugging, modifying and extending a model written in Firedrake is vastly easier than by traditional methods due to the small, highly mathematical code base. Firedrake supports a wide range of key features for dynamical core creation: A vast range of discretisations, including both continuous and discontinuous spaces and mimetic (C-grid-like) elements which optimally represent force balances in geophysical flows. High aspect ratio layered meshes suitable for ocean and atmosphere domains. Curved elements for high accuracy representations of the sphere. Support for non-finite element operators, such as parametrisations. Access to PETSc, a world-leading library of programmable linear and nonlinear solvers. High performance adjoint models generated automatically by symbolically reasoning about the forward model. This poster will present

  16. The finite element method in engineering, 2nd edition

    International Nuclear Information System (INIS)

    Rao, S.S.

    1986-01-01

    This work provides a systematic introduction to the various aspects of the finite element method as applied to engineering problems. Contents include: introduction to finite element method; solution of finite element equations; solid and structural mechanics; static analysis; dynamic analysis; heat transfer; fluid mechanics and additional applications

  17. A study on the nonlinear finite element analysis of reinforced concrete structures: shell finite element formulation

    Energy Technology Data Exchange (ETDEWEB)

    Lee, Sang Jin; Seo, Jeong Moon

    2000-08-01

    The main goal of this research is to establish a methodology of finite element analysis of containment building predicting not only global behaviour but also local failure mode. In this report, we summerize some existing numerical analysis techniques to be improved for containment building. In other words, a complete description of the standard degenerated shell finite element formulation is provided for nonlinear stress analysis of nuclear containment structure. A shell finite element is derived using the degenerated solid concept which does not rely on a specific shell theory. Reissner-Mindlin assumptions are adopted to consider the transverse shear deformation effect. In order to minimize the sensitivity of the constitutive equation to structural types, microscopic material model is adopted. The four solution algorithms based on the standard Newton-Raphson method are discussed. Finally, two numerical examples are carried out to test the performance of the adopted shell medel.

  18. A study on the nonlinear finite element analysis of reinforced concrete structures: shell finite element formulation

    International Nuclear Information System (INIS)

    Lee, Sang Jin; Seo, Jeong Moon

    2000-08-01

    The main goal of this research is to establish a methodology of finite element analysis of containment building predicting not only global behaviour but also local failure mode. In this report, we summerize some existing numerical analysis techniques to be improved for containment building. In other words, a complete description of the standard degenerated shell finite element formulation is provided for nonlinear stress analysis of nuclear containment structure. A shell finite element is derived using the degenerated solid concept which does not rely on a specific shell theory. Reissner-Mindlin assumptions are adopted to consider the transverse shear deformation effect. In order to minimize the sensitivity of the constitutive equation to structural types, microscopic material model is adopted. The four solution algorithms based on the standard Newton-Raphson method are discussed. Finally, two numerical examples are carried out to test the performance of the adopted shell medel

  19. A parallel finite-volume finite-element method for transient compressible turbulent flows with heat transfer

    International Nuclear Information System (INIS)

    Masoud Ziaei-Rad

    2010-01-01

    In this paper, a two-dimensional numerical scheme is presented for the simulation of turbulent, viscous, transient compressible flows in the simultaneously developing hydraulic and thermal boundary layer region. The numerical procedure is a finite-volume-based finite-element method applied to unstructured grids. This combination together with a new method applied for the boundary conditions allows for accurate computation of the variables in the entrance region and for a wide range of flow fields from subsonic to transonic. The Roe-Riemann solver is used for the convective terms, whereas the standard Galerkin technique is applied for the viscous terms. A modified κ-ε model with a two-layer equation for the near-wall region combined with a compressibility correction is used to predict the turbulent viscosity. Parallel processing is also employed to divide the computational domain among the different processors to reduce the computational time. The method is applied to some test cases in order to verify the numerical accuracy. The results show significant differences between incompressible and compressible flows in the friction coefficient, Nusselt number, shear stress and the ratio of the compressible turbulent viscosity to the molecular viscosity along the developing region. A transient flow generated after an accidental rupture in a pipeline was also studied as a test case. The results show that the present numerical scheme is stable, accurate and efficient enough to solve the problem of transient wall-bounded flow.

  20. Shallow-water sloshing in a moving vessel with variable cross-section and wetting-drying using an extension of George's well-balanced finite volume solver

    Science.gov (United States)

    Alemi Ardakani, Hamid; Bridges, Thomas J.; Turner, Matthew R.

    2016-06-01

    A class of augmented approximate Riemann solvers due to George (2008) [12] is extended to solve the shallow-water equations in a moving vessel with variable bottom topography and variable cross-section with wetting and drying. A class of Roe-type upwind solvers for the system of balance laws is derived which respects the steady-state solutions. The numerical solutions of the new adapted augmented f-wave solvers are validated against the Roe-type solvers. The theory is extended to solve the shallow-water flows in moving vessels with arbitrary cross-section with influx-efflux boundary conditions motivated by the shallow-water sloshing in the ocean wave energy converter (WEC) proposed by Offshore Wave Energy Ltd. (OWEL) [1]. A fractional step approach is used to handle the time-dependent forcing functions. The numerical solutions are compared to an extended new Roe-type solver for the system of balance laws with a time-dependent source function. The shallow-water sloshing finite volume solver can be coupled to a Runge-Kutta integrator for the vessel motion.

  1. Finite Element Analysis of Pipe T-Joint

    OpenAIRE

    P.M.Gedkar; Dr. D.V. Bhope

    2012-01-01

    This paper reports stress analysis of two pressurized cylindrical intersection using finite element method. The different combinations of dimensions of run pipe and the branch pipe are used to investigate thestresses in pipe at the intersection. In this study the stress analysis is accomplished by finite element package ANSYS.

  2. Introduction to finite element analysis using MATLAB and Abaqus

    CERN Document Server

    Khennane, Amar

    2013-01-01

    There are some books that target the theory of the finite element, while others focus on the programming side of things. Introduction to Finite Element Analysis Using MATLAB(R) and Abaqus accomplishes both. This book teaches the first principles of the finite element method. It presents the theory of the finite element method while maintaining a balance between its mathematical formulation, programming implementation, and application using commercial software. The computer implementation is carried out using MATLAB, while the practical applications are carried out in both MATLAB and Abaqus. MA

  3. Nonlinear finite element modeling of corrugated board

    Science.gov (United States)

    A. C. Gilchrist; J. C. Suhling; T. J. Urbanik

    1999-01-01

    In this research, an investigation on the mechanical behavior of corrugated board has been performed using finite element analysis. Numerical finite element models for corrugated board geometries have been created and executed. Both geometric (large deformation) and material nonlinearities were included in the models. The analyses were performed using the commercial...

  4. Peridynamic Multiscale Finite Element Methods

    Energy Technology Data Exchange (ETDEWEB)

    Costa, Timothy [Sandia National Lab. (SNL-NM), Albuquerque, NM (United States); Bond, Stephen D. [Sandia National Lab. (SNL-NM), Albuquerque, NM (United States); Littlewood, David John [Sandia National Lab. (SNL-NM), Albuquerque, NM (United States); Moore, Stan Gerald [Sandia National Lab. (SNL-NM), Albuquerque, NM (United States)

    2015-12-01

    The problem of computing quantum-accurate design-scale solutions to mechanics problems is rich with applications and serves as the background to modern multiscale science research. The prob- lem can be broken into component problems comprised of communicating across adjacent scales, which when strung together create a pipeline for information to travel from quantum scales to design scales. Traditionally, this involves connections between a) quantum electronic structure calculations and molecular dynamics and between b) molecular dynamics and local partial differ- ential equation models at the design scale. The second step, b), is particularly challenging since the appropriate scales of molecular dynamic and local partial differential equation models do not overlap. The peridynamic model for continuum mechanics provides an advantage in this endeavor, as the basic equations of peridynamics are valid at a wide range of scales limiting from the classical partial differential equation models valid at the design scale to the scale of molecular dynamics. In this work we focus on the development of multiscale finite element methods for the peridynamic model, in an effort to create a mathematically consistent channel for microscale information to travel from the upper limits of the molecular dynamics scale to the design scale. In particular, we first develop a Nonlocal Multiscale Finite Element Method which solves the peridynamic model at multiple scales to include microscale information at the coarse-scale. We then consider a method that solves a fine-scale peridynamic model to build element-support basis functions for a coarse- scale local partial differential equation model, called the Mixed Locality Multiscale Finite Element Method. Given decades of research and development into finite element codes for the local partial differential equation models of continuum mechanics there is a strong desire to couple local and nonlocal models to leverage the speed and state of the

  5. Finite Element Modeling of an Aircraft Tire Rolling on a Steel Drum: Experimental Investigations and Numerical Simulations

    Directory of Open Access Journals (Sweden)

    Iulian Rosu

    2018-04-01

    Full Text Available The aim of this study is to investigate the thermal evolution of an aircraft tire rolling at high velocities up to take off values. As this kind of experiment is difficult to realize on a real runway, experimental tests were realized on aircraft tires rolling on a steel drum. The rotating drum facility allows to apply variable velocities beyond the take off limits, at fixed skidding angles and loadings. The rolling conditions, vertical loading, velocity and cornering conditions were adopted to correspond to the real conditions of an aircraft tire running or skidding on a flat runway. In the experimental part, the influence of skidding angle, velocity and loading on the thermal evolution of the tire tread were investigated. The thermo-mechanical finite element analysis of a pneumatic radial tire structure was performed taking into account the hyper-viscoelastic rubber behavior, with heating mechanisms developed by the inelastic deformation and by friction. Three-dimensional finite element simulations of an aircraft tire rolling on a steel drum were carried out using Abaqus/Standard finite element solver. The comparison of the temperature distribution on the tire tread between numerical results and the experimental data shows the same overall tendencies. The good correlation between numerical and experimental data shows that numerical simulation could predict the thermal evolution of the tire in critical situations. The authors would like to mention that for confidentiality reason, certain numerical data could not be revealed.

  6. Bibliography for finite elements. [2200 references

    Energy Technology Data Exchange (ETDEWEB)

    Whiteman, J R [comp.

    1975-01-01

    This bibliography cites almost all of the significant papers on advances in the mathematical theory of finite elements. Reported are applications in aeronautical, civil, mechanical, nautical and nuclear engineering. Such topics as classical analysis, functional analysis, approximation theory, fluids, and diffusion are covered. Over 2200 references to publications up to the end of 1974 are included. Publications are listed alphabetically by author and also by keywords. In addition, finite element packages are listed.

  7. Complex finite element sensitivity method for creep analysis

    International Nuclear Information System (INIS)

    Gomez-Farias, Armando; Montoya, Arturo; Millwater, Harry

    2015-01-01

    The complex finite element method (ZFEM) has been extended to perform sensitivity analysis for mechanical and structural systems undergoing creep deformation. ZFEM uses a complex finite element formulation to provide shape, material, and loading derivatives of the system response, providing an insight into the essential factors which control the behavior of the system as a function of time. A complex variable-based quadrilateral user element (UEL) subroutine implementing the power law creep constitutive formulation was incorporated within the Abaqus commercial finite element software. The results of the complex finite element computations were verified by comparing them to the reference solution for the steady-state creep problem of a thick-walled cylinder in the power law creep range. A practical application of the ZFEM implementation to creep deformation analysis is the calculation of the skeletal point of a notched bar test from a single ZFEM run. In contrast, the standard finite element procedure requires multiple runs. The value of the skeletal point is that it identifies the location where the stress state is accurate, regardless of the certainty of the creep material properties. - Highlights: • A novel finite element sensitivity method (ZFEM) for creep was introduced. • ZFEM has the capability to calculate accurate partial derivatives. • ZFEM can be used for identification of the skeletal point of creep structures. • ZFEM can be easily implemented in a commercial software, e.g. Abaqus. • ZFEM results were shown to be in excellent agreement with analytical solutions

  8. A suitable low-order, eight-node tetrahedral finite element for solids

    Energy Technology Data Exchange (ETDEWEB)

    Key, S.W.; Heinstein, M.S.; Stone, C.M.; Mello, F.J.; Blanford, M.L.; Budge, K.G.

    1998-03-01

    To use the all-tetrahedral mesh generation existing today, the authors have explored the creation of a computationally efficient eight-node tetrahedral finite element (a four-node tetrahedral finite element enriched with four mid-face nodal points). The derivation of the element`s gradient operator, studies in obtaining a suitable mass lumping, and the element`s performance in applications are presented. In particular they examine the eight-node tetrahedral finite element`s behavior in longitudinal plane wave propagation, in transverse cylindrical wave propagation, and in simulating Taylor bar impacts. The element samples only constant strain states and, therefore, has 12 hour-glass modes. In this regard it bears similarities to the eight-node, mean-quadrature hexahedral finite element. Comparisons with the results obtained from the mean-quadrature eight-node hexahedral finite element and the four-node tetrahedral finite element are included. Given automatic all-tetrahedral meshing, the eight-node, constant-strain tetrahedral finite element is a suitable replacement for the eight-node hexahedral finite element in those cases where mesh generation requires an inordinate amount of user intervention and direction to obtain acceptable mesh properties.

  9. Application of Mass Lumped Higher Order Finite Elements

    International Nuclear Information System (INIS)

    J. Chen, H.R. Strauss, S.C. Jardin, W. Park, L.E. Sugiyama, G. Fu, J. Breslau

    2005-01-01

    There are many interesting phenomena in extended-MHD such as anisotropic transport, mhd, 2-fluid effects stellarator and hot particles. Any one of them challenges numerical analysts, and researchers are seeking for higher order methods, such as higher order finite difference, higher order finite elements and hp/spectral elements. It is true that these methods give more accurate solution than their linear counterparts. However, numerically they are prohibitively expensive. Here we give a successful solution of this conflict by applying mass lumped higher order finite elements. This type of elements not only keep second/third order accuracy but also scale closely to linear elements by doing mass lumping. This is especially true for second order lump elements. Full M3D and anisotropic transport models are studied

  10. The finite element method its basis and fundamentals

    CERN Document Server

    Zienkiewicz, Olek C; Zhu, JZ

    2013-01-01

    The Finite Element Method: Its Basis and Fundamentals offers a complete introduction to the basis of the finite element method, covering fundamental theory and worked examples in the detail required for readers to apply the knowledge to their own engineering problems and understand more advanced applications. This edition sees a significant rearrangement of the book's content to enable clearer development of the finite element method, with major new chapters and sections added to cover: Weak forms Variational forms Multi-dimensional field prob

  11. A suitable low-order, eight-node tetrahedral finite element for solids

    International Nuclear Information System (INIS)

    Key, S.W.; Heinstein, M.S.; Stone, C.M.; Mello, F.J.; Blanford, M.L.; Budge, K.G.

    1998-03-01

    To use the all-tetrahedral mesh generation existing today, the authors have explored the creation of a computationally efficient eight-node tetrahedral finite element (a four-node tetrahedral finite element enriched with four mid-face nodal points). The derivation of the element's gradient operator, studies in obtaining a suitable mass lumping, and the element's performance in applications are presented. In particular they examine the eight-node tetrahedral finite element's behavior in longitudinal plane wave propagation, in transverse cylindrical wave propagation, and in simulating Taylor bar impacts. The element samples only constant strain states and, therefore, has 12 hour-glass modes. In this regard it bears similarities to the eight-node, mean-quadrature hexahedral finite element. Comparisons with the results obtained from the mean-quadrature eight-node hexahedral finite element and the four-node tetrahedral finite element are included. Given automatic all-tetrahedral meshing, the eight-node, constant-strain tetrahedral finite element is a suitable replacement for the eight-node hexahedral finite element in those cases where mesh generation requires an inordinate amount of user intervention and direction to obtain acceptable mesh properties

  12. Patient-specific non-linear finite element modelling for predicting soft organ deformation in real-time: application to non-rigid neuroimage registration.

    Science.gov (United States)

    Wittek, Adam; Joldes, Grand; Couton, Mathieu; Warfield, Simon K; Miller, Karol

    2010-12-01

    Long computation times of non-linear (i.e. accounting for geometric and material non-linearity) biomechanical models have been regarded as one of the key factors preventing application of such models in predicting organ deformation for image-guided surgery. This contribution presents real-time patient-specific computation of the deformation field within the brain for six cases of brain shift induced by craniotomy (i.e. surgical opening of the skull) using specialised non-linear finite element procedures implemented on a graphics processing unit (GPU). In contrast to commercial finite element codes that rely on an updated Lagrangian formulation and implicit integration in time domain for steady state solutions, our procedures utilise the total Lagrangian formulation with explicit time stepping and dynamic relaxation. We used patient-specific finite element meshes consisting of hexahedral and non-locking tetrahedral elements, together with realistic material properties for the brain tissue and appropriate contact conditions at the boundaries. The loading was defined by prescribing deformations on the brain surface under the craniotomy. Application of the computed deformation fields to register (i.e. align) the preoperative and intraoperative images indicated that the models very accurately predict the intraoperative deformations within the brain. For each case, computing the brain deformation field took less than 4 s using an NVIDIA Tesla C870 GPU, which is two orders of magnitude reduction in computation time in comparison to our previous study in which the brain deformation was predicted using a commercial finite element solver executed on a personal computer. Copyright © 2010 Elsevier Ltd. All rights reserved.

  13. Direct solvers performance on h-adapted grids

    KAUST Repository

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

    2015-01-01

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

  14. Direct solvers performance on h-adapted grids

    KAUST Repository

    Paszynski, Maciej

    2015-05-27

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

  15. An Eulerian finite volume solver for multi-material fluid flows with cylindrical symmetry

    International Nuclear Information System (INIS)

    Bernard-Champmartin, Aude; Ghidaglia, Jean-Michel; Braeunig, Jean-Philippe

    2013-01-01

    In this paper, we adapt a pre-existing 2D cartesian cell centered finite volume solver to treat the compressible 3D Euler equations with cylindrical symmetry. We then extend it to multi-material flows. Assuming cylindrical symmetry with respect to the z axis (i.e. all the functions do not depend explicitly on the angular variable h), we obtain a set of five conservation laws with source terms that can be decoupled in two systems solved on a 2D orthogonal mesh in which a cell as a torus geometry. A specific up-winding treatment of the source term is required and implemented for the stationary case. Test cases will be presented for vanishing and non-vanishing azimuthal velocity uh. (authors)

  16. Finite element formulation for a digital image correlation method

    International Nuclear Information System (INIS)

    Sun Yaofeng; Pang, John H. L.; Wong, Chee Khuen; Su Fei

    2005-01-01

    A finite element formulation for a digital image correlation method is presented that will determine directly the complete, two-dimensional displacement field during the image correlation process on digital images. The entire interested image area is discretized into finite elements that are involved in the common image correlation process by use of our algorithms. This image correlation method with finite element formulation has an advantage over subset-based image correlation methods because it satisfies the requirements of displacement continuity and derivative continuity among elements on images. Numerical studies and a real experiment are used to verify the proposed formulation. Results have shown that the image correlation with the finite element formulation is computationally efficient, accurate, and robust

  17. Application of finite-element-methods in food processing

    DEFF Research Database (Denmark)

    Risum, Jørgen

    2004-01-01

    Presentation of the possible use of finite-element-methods in food processing. Examples from diffusion studies are given.......Presentation of the possible use of finite-element-methods in food processing. Examples from diffusion studies are given....

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

    International Nuclear Information System (INIS)

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

    2017-01-01

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

  19. On symmetric pyramidal finite elements

    Czech Academy of Sciences Publication Activity Database

    Liu, L.; Davies, K. B.; Yuan, K.; Křížek, Michal

    2004-01-01

    Roč. 11, 1-2 (2004), s. 213-227 ISSN 1492-8760 R&D Projects: GA AV ČR IAA1019201 Institutional research plan: CEZ:AV0Z1019905 Keywords : mesh generation * finite element method * composite elements Subject RIV: BA - General Mathematics Impact factor: 0.108, year: 2004

  20. Finite-element analysis of dynamic fracture

    Science.gov (United States)

    Aberson, J. A.; Anderson, J. M.; King, W. W.

    1976-01-01

    Applications of the finite element method to the two dimensional elastodynamics of cracked structures are presented. Stress intensity factors are computed for two problems involving stationary cracks. The first serves as a vehicle for discussing lumped-mass and consistent-mass characterizations of inertia. In the second problem, the behavior of a photoelastic dynamic tear test specimen is determined for the time prior to crack propagation. Some results of a finite element simulation of rapid crack propagation in an infinite body are discussed.

  1. The finite element method in electromagnetics

    CERN Document Server

    Jin, Jianming

    2014-01-01

    A new edition of the leading textbook on the finite element method, incorporating major advancements and further applications in the field of electromagnetics The finite element method (FEM) is a powerful simulation technique used to solve boundary-value problems in a variety of engineering circumstances. It has been widely used for analysis of electromagnetic fields in antennas, radar scattering, RF and microwave engineering, high-speed/high-frequency circuits, wireless communication, electromagnetic compatibility, photonics, remote sensing, biomedical engineering, and space exploration. The

  2. Finite elements for analysis and design

    CERN Document Server

    Akin, J E; Davenport, J H

    1994-01-01

    The finite element method (FEM) is an analysis tool for problem-solving used throughout applied mathematics, engineering, and scientific computing. Finite Elements for Analysis and Design provides a thoroughlyrevised and up-to-date account of this important tool and its numerous applications, with added emphasis on basic theory. Numerous worked examples are included to illustrate the material.Key Features* Akin clearly explains the FEM, a numerical analysis tool for problem-solving throughout applied mathematics, engineering and scientific computing* Basic theory has bee

  3. The finite element response matrix method

    International Nuclear Information System (INIS)

    Nakata, H.; Martin, W.R.

    1983-02-01

    A new technique is developed with an alternative formulation of the response matrix method implemented with the finite element scheme. Two types of response matrices are generated from the Galerkin solution to the weak form of the diffusion equation subject to an arbitrary current and source. The piecewise polynomials are defined in two levels, the first for the local (assembly) calculations and the second for the global (core) response matrix calculations. This finite element response matrix technique was tested in two 2-dimensional test problems, 2D-IAEA benchmark problem and Biblis benchmark problem, with satisfatory results. The computational time, whereas the current code is not extensively optimized, is of the same order of the well estabilished coarse mesh codes. Furthermore, the application of the finite element technique in an alternative formulation of response matrix method permits the method to easily incorporate additional capabilities such as treatment of spatially dependent cross-sections, arbitrary geometrical configurations, and high heterogeneous assemblies. (Author) [pt

  4. Finite Element Method in Machining Processes

    CERN Document Server

    Markopoulos, Angelos P

    2013-01-01

    Finite Element Method in Machining Processes provides a concise study on the way the Finite Element Method (FEM) is used in the case of manufacturing processes, primarily in machining. The basics of this kind of modeling are detailed to create a reference that will provide guidelines for those who start to study this method now, but also for scientists already involved in FEM and want to expand their research. A discussion on FEM, formulations and techniques currently in use is followed up by machining case studies. Orthogonal cutting, oblique cutting, 3D simulations for turning and milling, grinding, and state-of-the-art topics such as high speed machining and micromachining are explained with relevant examples. This is all supported by a literature review and a reference list for further study. As FEM is a key method for researchers in the manufacturing and especially in the machining sector, Finite Element Method in Machining Processes is a key reference for students studying manufacturing processes but al...

  5. An implementation analysis of the linear discontinuous finite element method

    International Nuclear Information System (INIS)

    Becker, T. L.

    2013-01-01

    This paper provides an implementation analysis of the linear discontinuous finite element method (LD-FEM) that spans the space of (l, x, y, z). A practical implementation of LD includes 1) selecting a computationally efficient algorithm to solve the 4 x 4 matrix system Ax = b that describes the angular flux in a mesh element, and 2) choosing how to store the data used to construct the matrix A and the vector b to either reduce memory consumption or increase computational speed. To analyze the first of these, three algorithms were selected to solve the 4 x 4 matrix equation: Cramer's rule, a streamlined implementation of Gaussian elimination, and LAPACK's Gaussian elimination subroutine dgesv. The results indicate that Cramer's rule and the streamlined Gaussian elimination algorithm perform nearly equivalently and outperform LAPACK's implementation of Gaussian elimination by a factor of 2. To analyze the second implementation detail, three formulations of the discretized LD-FEM equations were provided for implementation in a transport solver: 1) a low-memory formulation, which relies heavily on 'on-the-fly' calculations and less on the storage of pre-computed data, 2) a high-memory formulation, which pre-computes much of the data used to construct A and b, and 3) a reduced-memory formulation, which lies between the low - and high-memory formulations. These three formulations were assessed in the Jaguar transport solver based on relative memory footprint and computational speed for increasing mesh size and quadrature order. The results indicated that the memory savings of the low-memory formulation were not sufficient to warrant its implementation. The high-memory formulation resulted in a significant speed advantage over the reduced-memory option (10-50%), but also resulted in a proportional increase in memory consumption (5-45%) for increasing quadrature order and mesh count; therefore, the practitioner should weigh the system memory constraints against any

  6. An implementation analysis of the linear discontinuous finite element method

    Energy Technology Data Exchange (ETDEWEB)

    Becker, T. L. [Bechtel Marine Propulsion Corporation, Knolls Atomic Power Laboratory, P.O. Box 1072, Schenectady, NY 12301-1072 (United States)

    2013-07-01

    This paper provides an implementation analysis of the linear discontinuous finite element method (LD-FEM) that spans the space of (l, x, y, z). A practical implementation of LD includes 1) selecting a computationally efficient algorithm to solve the 4 x 4 matrix system Ax = b that describes the angular flux in a mesh element, and 2) choosing how to store the data used to construct the matrix A and the vector b to either reduce memory consumption or increase computational speed. To analyze the first of these, three algorithms were selected to solve the 4 x 4 matrix equation: Cramer's rule, a streamlined implementation of Gaussian elimination, and LAPACK's Gaussian elimination subroutine dgesv. The results indicate that Cramer's rule and the streamlined Gaussian elimination algorithm perform nearly equivalently and outperform LAPACK's implementation of Gaussian elimination by a factor of 2. To analyze the second implementation detail, three formulations of the discretized LD-FEM equations were provided for implementation in a transport solver: 1) a low-memory formulation, which relies heavily on 'on-the-fly' calculations and less on the storage of pre-computed data, 2) a high-memory formulation, which pre-computes much of the data used to construct A and b, and 3) a reduced-memory formulation, which lies between the low - and high-memory formulations. These three formulations were assessed in the Jaguar transport solver based on relative memory footprint and computational speed for increasing mesh size and quadrature order. The results indicated that the memory savings of the low-memory formulation were not sufficient to warrant its implementation. The high-memory formulation resulted in a significant speed advantage over the reduced-memory option (10-50%), but also resulted in a proportional increase in memory consumption (5-45%) for increasing quadrature order and mesh count; therefore, the practitioner should weigh the system memory

  7. Finite Element Modelling of Seismic Liquefaction in Soils

    NARCIS (Netherlands)

    Galavi, V.; Petalas, A.; Brinkgreve, R.B.J.

    2013-01-01

    Numerical aspects of seismic liquefaction in soils as implemented in the finite element code, PLAXIS, is described in this paper. After description of finite element equations of dynamic problems, three practical dynamic boundary conditions, namely viscous boundary tractions, tied degrees of freedom

  8. Mesh-size errors in diffusion-theory calculations using finite-difference and finite-element methods

    International Nuclear Information System (INIS)

    Baker, A.R.

    1982-07-01

    A study has been performed of mesh-size errors in diffusion-theory calculations using finite-difference and finite-element methods. As the objective was to illuminate the issues, the study was performed for a 1D slab model of a reactor with one neutron-energy group for which analytical solutions were possible. A computer code SLAB was specially written to perform the finite-difference and finite-element calculations and also to obtain the analytical solutions. The standard finite-difference equations were obtained by starting with an expansion of the neutron current in powers of the mesh size, h, and keeping terms as far as h 2 . It was confirmed that these equations led to the well-known result that the criticality parameter varied with the square of the mesh size. An improved form of the finite-difference equations was obtained by continuing the expansion for the neutron current as far as the term in h 4 . In this case, the critical parameter varied as the fourth power of the mesh size. The finite-element solutions for 2 and 3 nodes per element revealed that the criticality parameter varied as the square and fourth power of the mesh size, respectively. Numerical results are presented for a bare reactive core of uniform composition with 2 zones of different uniform mesh and for a reactive core with an absorptive reflector. (author)

  9. A geometric toolbox for tetrahedral finite element partitions

    NARCIS (Netherlands)

    Brandts, J.; Korotov, S.; Křížek, M.; Axelsson, O.; Karátson, J.

    2011-01-01

    In this work we present a survey of some geometric results on tetrahedral partitions and their refinements in a unified manner. They can be used for mesh generation and adaptivity in practical calculations by the finite element method (FEM), and also in theoretical finite element (FE) analysis.

  10. Mixed finite element simulations in two-dimensional groundwater flow problems

    International Nuclear Information System (INIS)

    Kimura, Hideo

    1989-01-01

    A computer code of groundwater flow in two-dimensional porous media based on the mixed finite element method was developed for accurate approximations of Darcy velocities in safety evaluation of radioactive waste disposal. The mixed finite element procedure solves for both the Darcy velocities and pressure heads simultaneously in the Darcy equation and continuity equation. Numerical results of a single well pumping at a constant rate in a uniform flow field showed that the mixed finite element method gives more accurate Darcy velocities nearly 50 % on average error than standard finite element method. (author)

  11. Finite element analysis of rotating beams physics based interpolation

    CERN Document Server

    Ganguli, Ranjan

    2017-01-01

    This book addresses the solution of rotating beam free-vibration problems using the finite element method. It provides an introduction to the governing equation of a rotating beam, before outlining the solution procedures using Rayleigh-Ritz, Galerkin and finite element methods. The possibility of improving the convergence of finite element methods through a judicious selection of interpolation functions, which are closer to the problem physics, is also addressed. The book offers a valuable guide for students and researchers working on rotating beam problems – important engineering structures used in helicopter rotors, wind turbines, gas turbines, steam turbines and propellers – and their applications. It can also be used as a textbook for specialized graduate and professional courses on advanced applications of finite element analysis.

  12. Impact of new computing systems on finite element computations

    International Nuclear Information System (INIS)

    Noor, A.K.; Fulton, R.E.; Storaasi, O.O.

    1983-01-01

    Recent advances in computer technology that are likely to impact finite element computations are reviewed. The characteristics of supersystems, highly parallel systems, and small systems (mini and microcomputers) are summarized. The interrelations of numerical algorithms and software with parallel architectures are discussed. A scenario is presented for future hardware/software environment and finite element systems. A number of research areas which have high potential for improving the effectiveness of finite element analysis in the new environment are identified

  13. Finite size effects of a pion matrix element

    International Nuclear Information System (INIS)

    Guagnelli, M.; Jansen, K.; Palombi, F.; Petronzio, R.; Shindler, A.; Wetzorke, I.

    2004-01-01

    We investigate finite size effects of the pion matrix element of the non-singlet, twist-2 operator corresponding to the average momentum of non-singlet quark densities. Using the quenched approximation, they come out to be surprisingly large when compared to the finite size effects of the pion mass. As a consequence, simulations of corresponding nucleon matrix elements could be affected by finite size effects even stronger which could lead to serious systematic uncertainties in their evaluation

  14. Variational approach to probabilistic finite elements

    Science.gov (United States)

    Belytschko, T.; Liu, W. K.; Mani, A.; Besterfield, G.

    1991-08-01

    Probabilistic finite element methods (PFEM), synthesizing the power of finite element methods with second-moment techniques, are formulated for various classes of problems in structural and solid mechanics. Time-invariant random materials, geometric properties and loads are incorporated in terms of their fundamental statistics viz. second-moments. Analogous to the discretization of the displacement field in finite element methods, the random fields are also discretized. Preserving the conceptual simplicity, the response moments are calculated with minimal computations. By incorporating certain computational techniques, these methods are shown to be capable of handling large systems with many sources of uncertainties. By construction, these methods are applicable when the scale of randomness is not very large and when the probabilistic density functions have decaying tails. The accuracy and efficiency of these methods, along with their limitations, are demonstrated by various applications. Results obtained are compared with those of Monte Carlo simulation and it is shown that good accuracy can be obtained for both linear and nonlinear problems. The methods are amenable to implementation in deterministic FEM based computer codes.

  15. Verification of Orthogrid Finite Element Modeling Techniques

    Science.gov (United States)

    Steeve, B. E.

    1996-01-01

    The stress analysis of orthogrid structures, specifically with I-beam sections, is regularly performed using finite elements. Various modeling techniques are often used to simplify the modeling process but still adequately capture the actual hardware behavior. The accuracy of such 'Oshort cutso' is sometimes in question. This report compares three modeling techniques to actual test results from a loaded orthogrid panel. The finite element models include a beam, shell, and mixed beam and shell element model. Results show that the shell element model performs the best, but that the simpler beam and beam and shell element models provide reasonable to conservative results for a stress analysis. When deflection and stiffness is critical, it is important to capture the effect of the orthogrid nodes in the model.

  16. Review of Tomographic Imaging using Finite Element Method

    Directory of Open Access Journals (Sweden)

    Mohd Fua’ad RAHMAT

    2011-12-01

    Full Text Available Many types of techniques for process tomography were proposed and developed during the past 20 years. This paper review the techniques and the current state of knowledge and experience on the subject, aimed at highlighting the problems associated with the non finite element methods, such as the ill posed, ill conditioned which relates to the accuracy and sensitivity of measurements. In this paper, considerations for choice of sensors and its applications were outlined and descriptions of non finite element tomography systems were presented. The finite element method tomography system as obtained from recent works, suitable for process control and measurement were also presented.

  17. Magnetic materials and 3D finite element modeling

    CERN Document Server

    Bastos, Joao Pedro A

    2014-01-01

    Magnetic Materials and 3D Finite Element Modeling explores material characterization and finite element modeling (FEM) applications. This book relates to electromagnetic analysis based on Maxwell’s equations and application of the finite element (FE) method to low frequency devices. A great source for senior undergraduate and graduate students in electromagnetics, it also supports industry professionals working in magnetics, electromagnetics, ferromagnetic materials science and electrical engineering. The authors present current concepts on ferromagnetic material characterizations and losses. They provide introductory material; highlight basic electromagnetics, present experimental and numerical modeling related to losses and focus on FEM applied to 3D applications. They also explain various formulations, and discuss numerical codes.

  18. New mixed finite-element methods

    International Nuclear Information System (INIS)

    Franca, L.P.

    1987-01-01

    New finite-element methods are proposed for mixed variational formulations. The methods are constructed by adding to the classical Galerkin method various least-squares like terms. The additional terms involve integrals over element interiors, and include mesh-parameter dependent coefficients. The methods are designed to enhance stability. Consistency is achieved in the sense that exact solutions identically satisfy the variational equations.Applied to several problems, simple finite-element interpolations are rendered convergent, including convenient equal-order interpolations generally unstable within the Galerkin approach. The methods are subdivided into two classes according to the manner in which stability is attained: (1) circumventing Babuska-Brezzi condition methods; (2) satisfying Babuska-Brezzi condition methods. Convergence is established for each class of methods. Applications of the first class of methods to Stokes flow and compressible linear elasticity are presented. The second class of methods is applied to the Poisson, Timoshenko beam and incompressible elasticity problems. Numerical results demonstrate the good stability and accuracy of the methods, and confirm the error estimates

  19. Divergence-free MHD on unstructured meshes using high order finite volume schemes based on multidimensional Riemann solvers

    Science.gov (United States)

    Balsara, Dinshaw S.; Dumbser, Michael

    2015-10-01

    Several advances have been reported in the recent literature on divergence-free finite volume schemes for Magnetohydrodynamics (MHD). Almost all of these advances are restricted to structured meshes. To retain full geometric versatility, however, it is also very important to make analogous advances in divergence-free schemes for MHD on unstructured meshes. Such schemes utilize a staggered Yee-type mesh, where all hydrodynamic quantities (mass, momentum and energy density) are cell-centered, while the magnetic fields are face-centered and the electric fields, which are so useful for the time update of the magnetic field, are centered at the edges. Three important advances are brought together in this paper in order to make it possible to have high order accurate finite volume schemes for the MHD equations on unstructured meshes. First, it is shown that a divergence-free WENO reconstruction of the magnetic field can be developed for unstructured meshes in two and three space dimensions using a classical cell-centered WENO algorithm, without the need to do a WENO reconstruction for the magnetic field on the faces. This is achieved via a novel constrained L2-projection operator that is used in each time step as a postprocessor of the cell-centered WENO reconstruction so that the magnetic field becomes locally and globally divergence free. Second, it is shown that recently-developed genuinely multidimensional Riemann solvers (called MuSIC Riemann solvers) can be used on unstructured meshes to obtain a multidimensionally upwinded representation of the electric field at each edge. Third, the above two innovations work well together with a high order accurate one-step ADER time stepping strategy, which requires the divergence-free nonlinear WENO reconstruction procedure to be carried out only once per time step. The resulting divergence-free ADER-WENO schemes with MuSIC Riemann solvers give us an efficient and easily-implemented strategy for divergence-free MHD on

  20. On higher order pyramidal finite elements

    Czech Academy of Sciences Publication Activity Database

    Liu, L.; Davies, K.B.; Křížek, Michal; Guan, L.

    2011-01-01

    Roč. 3, č. 2 (2011), s. 131-140 ISSN 2070-0733 R&D Projects: GA AV ČR(CZ) IAA100190803 Institutional research plan: CEZ:AV0Z10190503 Keywords : pyramidal polynomial basis functions * finite element method * composite elements * three-dimensional mortar elements Subject RIV: BA - General Mathematics Impact factor: 0.750, year: 2011

  1. Numerical simulations of earthquakes and the dynamics of fault systems using the Finite Element method.

    Science.gov (United States)

    Kettle, L. M.; Mora, P.; Weatherley, D.; Gross, L.; Xing, H.

    2006-12-01

    Simulations using the Finite Element method are widely used in many engineering applications and for the solution of partial differential equations (PDEs). Computational models based on the solution of PDEs play a key role in earth systems simulations. We present numerical modelling of crustal fault systems where the dynamic elastic wave equation is solved using the Finite Element method. This is achieved using a high level computational modelling language, escript, available as open source software from ACcESS (Australian Computational Earth Systems Simulator), the University of Queensland. Escript is an advanced geophysical simulation software package developed at ACcESS which includes parallel equation solvers, data visualisation and data analysis software. The escript library was implemented to develop a flexible Finite Element model which reliably simulates the mechanism of faulting and the physics of earthquakes. Both 2D and 3D elastodynamic models are being developed to study the dynamics of crustal fault systems. Our final goal is to build a flexible model which can be applied to any fault system with user-defined geometry and input parameters. To study the physics of earthquake processes, two different time scales must be modelled, firstly the quasi-static loading phase which gradually increases stress in the system (~100years), and secondly the dynamic rupture process which rapidly redistributes stress in the system (~100secs). We will discuss the solution of the time-dependent elastic wave equation for an arbitrary fault system using escript. This involves prescribing the correct initial stress distribution in the system to simulate the quasi-static loading of faults to failure; determining a suitable frictional constitutive law which accurately reproduces the dynamics of the stick/slip instability at the faults; and using a robust time integration scheme. These dynamic models generate data and information that can be used for earthquake forecasting.

  2. Combined finite element and multibody musculoskeletal investigation of a fractured clavicle with reconstruction plate

    DEFF Research Database (Denmark)

    Cronskar, Marie; Rasmussen, John; Tinnsten, Mats

    2015-01-01

    This paper addresses the various treatment options for clavicle fractures by means of computational models, more precisely cases with a need for internal fixation: non-unions and certain complex fractures. The motivation for the work is that treatment can be enhanced by a better understanding...... of the loading of the clavicle and fixation device. This study aimed to develop a method for realistic simulation of stresses in the bone and fixation device in the case of a fractured clavicle. A finite element (FE) mesh of the clavicle geometry was created from computer tomography (CT) data and imported...... into the FE solver where the model was subjected to muscle forces and other boundary conditions from a multibody musculoskeletal model performing a typical activity of daily life. A reconstruction plate and screws were also imported into the model. The combination models returned stresses and displacements...

  3. 3D visualization and finite element mesh formation from wood anatomy samples, Part II – Algorithm approach

    Directory of Open Access Journals (Sweden)

    Petr Koňas

    2009-01-01

    Full Text Available Paper presents new original application WOOD3D in form of program code assembling. The work extends the previous article “Part I – Theoretical approach” in detail description of implemented C++ classes of utilized projects Visualization Toolkit (VTK, Insight Toolkit (ITK and MIMX. Code is written in CMake style and it is available as multiplatform application. Currently GNU Linux (32/64b and MS Windows (32/64b platforms were released. Article discusses various filter classes for image filtering. Mainly Otsu and Binary threshold filters are classified for anatomy wood samples thresholding. Registration of images series is emphasized for difference of colour spaces compensation is included. Resulted work flow of image analysis is new methodological approach for images processing through the composition, visualization, filtering, registration and finite element mesh formation. Application generates script in ANSYS parametric design language (APDL which is fully compatible with ANSYS finite element solver and designer environment. The script includes the whole definition of unstructured finite element mesh formed by individual elements and nodes. Due to simple notation, the same script can be used for generation of geometrical entities in element positions. Such formed volumetric entities are prepared for further geometry approximation (e.g. by boolean or more advanced methods. Hexahedral and tetrahedral types of mesh elements are formed on user request with specified mesh options. Hexahedral meshes are formed both with uniform element size and with anisotropic character. Modified octree method for hexahedral mesh with anisotropic character was declared in application. Multicore CPUs in the application are supported for fast image analysis realization. Visualization of image series and consequent 3D image are realized in VTK format sufficiently known and public format, visualized in GPL application Paraview. Future work based on mesh

  4. Validation of High Displacement Piezoelectric Actuator Finite Element Models

    Science.gov (United States)

    Taleghani, B. K.

    2000-01-01

    The paper presents the results obtained by using NASTRAN(Registered Trademark) and ANSYS(Regitered Trademark) finite element codes to predict doming of the THUNDER piezoelectric actuators during the manufacturing process and subsequent straining due to an applied input voltage. To effectively use such devices in engineering applications, modeling and characterization are essential. Length, width, dome height, and thickness are important parameters for users of such devices. Therefore, finite element models were used to assess the effects of these parameters. NASTRAN(Registered Trademark) and ANSYS(Registered Trademark) used different methods for modeling piezoelectric effects. In NASTRAN(Registered Trademark), a thermal analogy was used to represent voltage at nodes as equivalent temperatures, while ANSYS(Registered Trademark) processed the voltage directly using piezoelectric finite elements. The results of finite element models were validated by using the experimental results.

  5. The finite-difference and finite-element modeling of seismic wave propagation and earthquake motion

    International Nuclear Information System (INIS)

    Moszo, P.; Kristek, J.; Galis, M.; Pazak, P.; Balazovijech, M.

    2006-01-01

    Numerical modeling of seismic wave propagation and earthquake motion is an irreplaceable tool in investigation of the Earth's structure, processes in the Earth, and particularly earthquake phenomena. Among various numerical methods, the finite-difference method is the dominant method in the modeling of earthquake motion. Moreover, it is becoming more important in the seismic exploration and structural modeling. At the same time we are convinced that the best time of the finite-difference method in seismology is in the future. This monograph provides tutorial and detailed introduction to the application of the finite-difference, finite-element, and hybrid finite-difference-finite-element methods to the modeling of seismic wave propagation and earthquake motion. The text does not cover all topics and aspects of the methods. We focus on those to which we have contributed. (Author)

  6. A set of pathological tests to validate new finite elements

    Indian Academy of Sciences (India)

    M. Senthilkumar (Newgen Imaging) 1461 1996 Oct 15 13:05:22

    The finite element method entails several approximations. Hence it ... researchers have designed several pathological tests to validate any new finite element. The .... Three dimensional thick shell elements using a hybrid/mixed formu- lation.

  7. Crack Propagation by Finite Element Method

    Directory of Open Access Journals (Sweden)

    Luiz Carlos H. Ricardo

    2018-01-01

    Full Text Available Crack propagation simulation began with the development of the finite element method; the analyses were conducted to obtain a basic understanding of the crack growth. Today structural and materials engineers develop structures and materials properties using this technique. The aim of this paper is to verify the effect of different crack propagation rates in determination of crack opening and closing stress of an ASTM specimen under a standard suspension spectrum loading from FDandE SAE Keyhole Specimen Test Load Histories by finite element analysis. To understand the crack propagation processes under variable amplitude loading, retardation effects are observed

  8. Finite element analysis of plastic recycling machine designed for ...

    African Journals Online (AJOL)

    ... design was evaluated using finite element analysis (FEA) tool in Solid Works Computer ... Also, a minimum factor of safety value of 5.3 was obtained for shredder shaft ... Machine; Design; Recycling; Sustainability; Finite Element; Simulation ...

  9. An introduction to the UNCLE finite element scheme

    International Nuclear Information System (INIS)

    Enderby, J.A.

    1983-01-01

    UNCLE is a completely general finite element scheme which provides common input, output, equation-solving and other facilities for a family of finite element codes for linear and non-linear stress analysis, heat transfer etc. This report describes the concepts on which UNCLE is based and gives a general account of the facilities provided. (author)

  10. An introduction to the UNCLE finite element scheme

    Energy Technology Data Exchange (ETDEWEB)

    Enderby, J A [UK Atomic Energy Authority, Northern Division, Risley Nuclear Power Development Establishment, Risley, Warrington (United Kingdom)

    1983-05-01

    UNCLE is a completely general finite element scheme which provides common input, output, equation-solving and other facilities for a family of finite element codes for linear and non-linear stress analysis, heat transfer etc. This report describes the concepts on which UNCLE is based and gives a general account of the facilities provided. (author)

  11. Finite element analysis of hybrid energy harvesting of piezoelectric and electromagnetic

    Directory of Open Access Journals (Sweden)

    Muhammad Yazid Muhammad Ammar Faris

    2017-01-01

    Full Text Available Harvesting energy from ambient vibrations is a highly required method because of the wide range of available sources that produce vibration energy application from industrial machinery to human motion application. In this paper, the implementation of harvesting energy from two technologies to form a hybrid energy harvester system was analyzed. These two technologies involve the piezoelectric harvesting energy and the electromagnetic harvesting energy. A finite element model was developed using the Ansys software with the harmonic analysis solver to analyze and examine hybrid harvesting energy system. Both power output generated from the magnet and the piezoelectric is then combined to form one unit of energy. Further, it was found that the result shows the system generate the maximum power output of 14.85 μW from 100 Hz, 4.905 m/s2, and 0.6 cm3 for resonance frequency, acceleration, and the volume respectively from the optimal energy harvester design. Normalized Power Density (NPD result of 10.29 kgs/m3 comparable with other literature also can be used in energy harvesting system for vibration application.

  12. A particle finite element method for machining simulations

    Science.gov (United States)

    Sabel, Matthias; Sator, Christian; Müller, Ralf

    2014-07-01

    The particle finite element method (PFEM) appears to be a convenient technique for machining simulations, since the geometry and topology of the problem can undergo severe changes. In this work, a short outline of the PFEM-algorithm is given, which is followed by a detailed description of the involved operations. The -shape method, which is used to track the topology, is explained and tested by a simple example. Also the kinematics and a suitable finite element formulation are introduced. To validate the method simple settings without topological changes are considered and compared to the standard finite element method for large deformations. To examine the performance of the method, when dealing with separating material, a tensile loading is applied to a notched plate. This investigation includes a numerical analysis of the different meshing parameters, and the numerical convergence is studied. With regard to the cutting simulation it is found that only a sufficiently large number of particles (and thus a rather fine finite element discretisation) leads to converged results of process parameters, such as the cutting force.

  13. On the reliability of finite element solutions

    International Nuclear Information System (INIS)

    Prasad, K.S.R.K.

    1975-01-01

    The extent of reliability of the finite element method for analysis of nuclear reactor structures, and that of reactor vessels in particular and the need for the engineer to guard against the pitfalls that may arise out of both physical and mathematical models have been high-lighted. A systematic way of checking the model to obtain reasonably accurate solutions is presented. Quite often sophisticated elements are suggested for specific design and stress concentration problems. The desirability or otherwise of these elements, their scope and utility vis-a-vis the use of large stack of conventional elements are discussed from the view point of stress analysts. The methods of obtaining a check on the reliability of the finite element solutions either through modelling changes or an extrapolation technique are discussed. (author)

  14. 3-D minimum-structure inversion of magnetotelluric data using the finite-element method and tetrahedral grids

    Science.gov (United States)

    Jahandari, H.; Farquharson, C. G.

    2017-11-01

    Unstructured grids enable representing arbitrary structures more accurately and with fewer cells compared to regular structured grids. These grids also allow more efficient refinements compared to rectilinear meshes. In this study, tetrahedral grids are used for the inversion of magnetotelluric (MT) data, which allows for the direct inclusion of topography in the model, for constraining an inversion using a wireframe-based geological model and for local refinement at the observation stations. A minimum-structure method with an iterative model-space Gauss-Newton algorithm for optimization is used. An iterative solver is employed for solving the normal system of equations at each Gauss-Newton step and the sensitivity matrix-vector products that are required by this solver are calculated using pseudo-forward problems. This method alleviates the need to explicitly form the Hessian or Jacobian matrices which significantly reduces the required computation memory. Forward problems are formulated using an edge-based finite-element approach and a sparse direct solver is used for the solutions. This solver allows saving and re-using the factorization of matrices for similar pseudo-forward problems within a Gauss-Newton iteration which greatly minimizes the computation time. Two examples are presented to show the capability of the algorithm: the first example uses a benchmark model while the second example represents a realistic geological setting with topography and a sulphide deposit. The data that are inverted are the full-tensor impedance and the magnetic transfer function vector. The inversions sufficiently recovered the models and reproduced the data, which shows the effectiveness of unstructured grids for complex and realistic MT inversion scenarios. The first example is also used to demonstrate the computational efficiency of the presented model-space method by comparison with its data-space counterpart.

  15. Adaptive Smoothed Finite Elements (ASFEM) for history dependent material models

    International Nuclear Information System (INIS)

    Quak, W.; Boogaard, A. H. van den

    2011-01-01

    A successful simulation of a bulk forming process with finite elements can be difficult due to distortion of the finite elements. Nodal smoothed Finite Elements (NSFEM) are an interesting option for such a process since they show good distortion insensitivity and moreover have locking-free behavior and good computational efficiency. In this paper a method is proposed which takes advantage of the nodally smoothed field. This method, named adaptive smoothed finite elements (ASFEM), revises the mesh for every step of a simulation without mapping the history dependent material parameters. In this paper an updated-Lagrangian implementation is presented. Several examples are given to illustrate the method and to show its properties.

  16. Automation of finite element methods

    CERN Document Server

    Korelc, Jože

    2016-01-01

    New finite elements are needed as well in research as in industry environments for the development of virtual prediction techniques. The design and implementation of novel finite elements for specific purposes is a tedious and time consuming task, especially for nonlinear formulations. The automation of this process can help to speed up this process considerably since the generation of the final computer code can be accelerated by order of several magnitudes. This book provides the reader with the required knowledge needed to employ modern automatic tools like AceGen within solid mechanics in a successful way. It covers the range from the theoretical background, algorithmic treatments to many different applications. The book is written for advanced students in the engineering field and for researchers in educational and industrial environments.

  17. Finite Element Based Design and Optimization for Piezoelectric Accelerometers

    DEFF Research Database (Denmark)

    Liu, Bin; Kriegbaum, B.; Yao, Q.

    1998-01-01

    A systematic Finite Element design and optimisation procedure is implemented for the development of piezoelectric accelerometers. Most of the specifications of accelerometers can be obtained using the Finite Element simulations. The deviations between the simulated and calibrated sensitivities...

  18. THE PRACTICAL ANALYSIS OF FINITE ELEMENTS METHOD ERRORS

    Directory of Open Access Journals (Sweden)

    Natalia Bakhova

    2011-03-01

    Full Text Available Abstract. The most important in the practical plan questions of reliable estimations of finite elementsmethod errors are considered. Definition rules of necessary calculations accuracy are developed. Methodsand ways of the calculations allowing receiving at economical expenditures of computing work the best finalresults are offered.Keywords: error, given the accuracy, finite element method, lagrangian and hermitian elements.

  19. ABOUT SOLUTION OF MULTIPOINT BOUNDARY PROBLEMS OF TWO-DIMENSIONAL STRUCTURAL ANALYSIS WITH THE USE OF COMBINED APPLICATION OF FINITE ELEMENT METHOD AND DISCRETE-CONTINUAL FINITE ELEMENT METHOD PART 2: SPECIAL ASPECTS OF FINITE ELEMENT APPROXIMATION

    Directory of Open Access Journals (Sweden)

    Pavel A. Akimov

    2017-12-01

    Full Text Available As is well known, the formulation of a multipoint boundary problem involves three main components: a description of the domain occupied by the structure and the corresponding subdomains; description of the conditions inside the domain and inside the corresponding subdomains, the description of the conditions on the boundary of the domain, conditions on the boundaries between subdomains. This paper is a continuation of another work published earlier, in which the formulation and general principles of the approximation of the multipoint boundary problem of a static analysis of deep beam on the basis of the joint application of the finite element method and the discrete-continual finite element method were considered. It should be noted that the approximation within the fragments of a domain that have regular physical-geometric parameters along one of the directions is expedient to be carried out on the basis of the discrete-continual finite element method (DCFEM, and for the approximation of all other fragments it is necessary to use the standard finite element method (FEM. In the present publication, the formulas for the computing of displacements partial derivatives of displacements, strains and stresses within the finite element model (both within the finite element and the corresponding nodal values (with the use of averaging are presented. Boundary conditions between subdomains (respectively, discrete models and discrete-continual models and typical conditions such as “hinged support”, “free edge”, “perfect contact” (twelve basic (basic variants are available are under consideration as well. Governing formulas for computing of elements of the corresponding matrices of coefficients and vectors of the right-hand sides are given for each variant. All formulas are fully adapted for algorithmic implementation.

  20. FELIX-2.0: New version of the finite element solver for the time dependent generator coordinate method with the Gaussian overlap approximation

    Science.gov (United States)

    Regnier, D.; Dubray, N.; Verrière, M.; Schunck, N.

    2018-04-01

    The time-dependent generator coordinate method (TDGCM) is a powerful method to study the large amplitude collective motion of quantum many-body systems such as atomic nuclei. Under the Gaussian Overlap Approximation (GOA), the TDGCM leads to a local, time-dependent Schrödinger equation in a multi-dimensional collective space. In this paper, we present the version 2.0 of the code FELIX that solves the collective Schrödinger equation in a finite element basis. This new version features: (i) the ability to solve a generalized TDGCM+GOA equation with a metric term in the collective Hamiltonian, (ii) support for new kinds of finite elements and different types of quadrature to compute the discretized Hamiltonian and overlap matrices, (iii) the possibility to leverage the spectral element scheme, (iv) an explicit Krylov approximation of the time propagator for time integration instead of the implicit Crank-Nicolson method implemented in the first version, (v) an entirely redesigned workflow. We benchmark this release on an analytic problem as well as on realistic two-dimensional calculations of the low-energy fission of 240Pu and 256Fm. Low to moderate numerical precision calculations are most efficiently performed with simplex elements with a degree 2 polynomial basis. Higher precision calculations should instead use the spectral element method with a degree 4 polynomial basis. We emphasize that in a realistic calculation of fission mass distributions of 240Pu, FELIX-2.0 is about 20 times faster than its previous release (within a numerical precision of a few percents).

  1. Finite element simulation and testing of ISW CFRP anchorage

    DEFF Research Database (Denmark)

    Schmidt, Jacob Wittrup; Goltermann, Per; Hertz, Kristian Dahl

    2013-01-01

    is modelled in the 3D finite Element program ABAQUS, just as digital image correlation (DIC) testing was performed to verify the finite element simulation. Also a new optimized design was produced to ensure that the finite element simulation and anchorage behaviour correlated well. It is seen....... This paper presents a novel mechanical integrated sleeve wedge anchorage which seem very promising when perusing the scope of ultimate utilization of CFRP 8mm rods (with a tension capacity of approximately 140kN). Compression transverse to the CFRP is evaluated to prevent premature failure. The anchorage...

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

    KAUST Repository

    Liu, Yang

    2014-09-26

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

  3. Hydrothermal analysis in engineering using control volume finite element method

    CERN Document Server

    Sheikholeslami, Mohsen

    2015-01-01

    Control volume finite element methods (CVFEM) bridge the gap between finite difference and finite element methods, using the advantages of both methods for simulation of multi-physics problems in complex geometries. In Hydrothermal Analysis in Engineering Using Control Volume Finite Element Method, CVFEM is covered in detail and applied to key areas of thermal engineering. Examples, exercises, and extensive references are used to show the use of the technique to model key engineering problems such as heat transfer in nanofluids (to enhance performance and compactness of energy systems),

  4. A multiscale mortar multipoint flux mixed finite element method

    KAUST Repository

    Wheeler, Mary Fanett; Xue, Guangri; Yotov, Ivan

    2012-01-01

    In this paper, we develop a multiscale mortar multipoint flux mixed finite element method for second order elliptic problems. The equations in the coarse elements (or subdomains) are discretized on a fine grid scale by a multipoint flux mixed finite

  5. Parallel iterative procedures for approximate solutions of wave propagation by finite element and finite difference methods

    Energy Technology Data Exchange (ETDEWEB)

    Kim, S. [Purdue Univ., West Lafayette, IN (United States)

    1994-12-31

    Parallel iterative procedures based on domain decomposition techniques are defined and analyzed for the numerical solution of wave propagation by finite element and finite difference methods. For finite element methods, in a Lagrangian framework, an efficient way for choosing the algorithm parameter as well as the algorithm convergence are indicated. Some heuristic arguments for finding the algorithm parameter for finite difference schemes are addressed. Numerical results are presented to indicate the effectiveness of the methods.

  6. DynEarthSol2D: An efficient unstructured finite element method to study long-term tectonic deformation

    KAUST Repository

    Choi, E.; Tan, E.; Lavier, L. L.; Calo, Victor M.

    2013-01-01

    Many tectonic problems require to treat the lithosphere as a compressible elastic material, which can also flow viscously or break in a brittle fashion depending on the stress level applied and the temperature conditions. We present a flexible methodology to address the resulting complex material response, which imposes severe challenges on the discretization and rheological models used. This robust, adaptive, two-dimensional, finite element method solves the momentum balance and the heat equation in Lagrangian form using unstructured meshes. An implementation of this methodology is released to the public with the publication of this paper and is named DynEarthSol2D (available at http://bitbucket.org/tan2/dynearthsol2). The solver uses contingent mesh adaptivity in places where shear strain is focused (localization) and a conservative mapping assisted by marker particles to preserve phase and facies boundaries during remeshing. We detail the solver and verify it in a number of benchmark problems against analytic and numerical solutions from the literature. These results allow us to verify and validate our software framework and show its improved performance by an order of magnitude compared against an earlier implementation of the Fast Lagrangian Analysis of Continua algorithm.

  7. DynEarthSol2D: An efficient unstructured finite element method to study long-term tectonic deformation

    KAUST Repository

    Choi, E.

    2013-05-01

    Many tectonic problems require to treat the lithosphere as a compressible elastic material, which can also flow viscously or break in a brittle fashion depending on the stress level applied and the temperature conditions. We present a flexible methodology to address the resulting complex material response, which imposes severe challenges on the discretization and rheological models used. This robust, adaptive, two-dimensional, finite element method solves the momentum balance and the heat equation in Lagrangian form using unstructured meshes. An implementation of this methodology is released to the public with the publication of this paper and is named DynEarthSol2D (available at http://bitbucket.org/tan2/dynearthsol2). The solver uses contingent mesh adaptivity in places where shear strain is focused (localization) and a conservative mapping assisted by marker particles to preserve phase and facies boundaries during remeshing. We detail the solver and verify it in a number of benchmark problems against analytic and numerical solutions from the literature. These results allow us to verify and validate our software framework and show its improved performance by an order of magnitude compared against an earlier implementation of the Fast Lagrangian Analysis of Continua algorithm.

  8. Global-Local Finite Element Analysis of Bonded Single-Lap Joints

    Science.gov (United States)

    Kilic, Bahattin; Madenci, Erdogan; Ambur, Damodar R.

    2004-01-01

    Adhesively bonded lap joints involve dissimilar material junctions and sharp changes in geometry, possibly leading to premature failure. Although the finite element method is well suited to model the bonded lap joints, traditional finite elements are incapable of correctly resolving the stress state at junctions of dissimilar materials because of the unbounded nature of the stresses. In order to facilitate the use of bonded lap joints in future structures, this study presents a finite element technique utilizing a global (special) element coupled with traditional elements. The global element includes the singular behavior at the junction of dissimilar materials with or without traction-free surfaces.

  9. Krylov solvers preconditioned with the low-order red-black algorithm for the PN hybrid FEM for the instant code

    Energy Technology Data Exchange (ETDEWEB)

    Wang, Yaqi; Rabiti, Cristian; Palmiotti, Giuseppe, E-mail: yaqi.wang@inl.gov, E-mail: cristian.rabiti@inl.gov, E-mail: giuseppe.palmiotti@inl.gov [Idaho National Laboratory, Idaho Falls, ID (United States)

    2011-07-01

    This paper proposes a new set of Krylov solvers, CG and GMRes, as an alternative of the Red-Black (RB) algorithm on on solving the steady-state one-speed neutron transport equation discretized with PN in angle and hybrid FEM (Finite Element Method) in space. A pre conditioner with the low-order RB iteration is designed to improve their convergence. These Krylov solvers can reduce the cost of pre-assembling the response matrices greatly. Numerical results with the INSTANT code are presented in order to show that they can be a good supplement on solving the PN-HFEM system. (author)

  10. Krylov solvers preconditioned with the low-order red-black algorithm for the PN hybrid FEM for the instant code

    International Nuclear Information System (INIS)

    Wang, Yaqi; Rabiti, Cristian; Palmiotti, Giuseppe

    2011-01-01

    This paper proposes a new set of Krylov solvers, CG and GMRes, as an alternative of the Red-Black (RB) algorithm on on solving the steady-state one-speed neutron transport equation discretized with PN in angle and hybrid FEM (Finite Element Method) in space. A pre conditioner with the low-order RB iteration is designed to improve their convergence. These Krylov solvers can reduce the cost of pre-assembling the response matrices greatly. Numerical results with the INSTANT code are presented in order to show that they can be a good supplement on solving the PN-HFEM system. (author)

  11. Finite element simulation of laser transmission welding of dissimilar ...

    African Journals Online (AJOL)

    user

    materials between polyvinylidene fluoride and titanium ... finite element (FE) thermal model is developed to simulate the laser ... Keywords: Laser transmission welding, Temperature field, Weld dimension, Finite element analysis, Thermal modeling. 1. .... 4) The heating phenomena due to the phase changes are neglected.

  12. Finite element analysis of tibial fractures

    DEFF Research Database (Denmark)

    Wong, Christian Nai En; Mikkelsen, Mikkel Peter W; Hansen, Leif Berner

    2010-01-01

    Project. The data consisted of 21,219 3D elements with a cortical shell and a trabecular core. Three types of load of torsion, a direct lateral load and axial compression were applied. RESULTS: The finite element linear static analysis resulted in relevant fracture localizations and indicated relevant...

  13. Efficient combination of a 3D Quasi-Newton inversion algorithm and a vector dual-primal finite element tearing and interconnecting method

    International Nuclear Information System (INIS)

    Voznyuk, I; Litman, A; Tortel, H

    2015-01-01

    A Quasi-Newton method for reconstructing the constitutive parameters of three-dimensional (3D) penetrable scatterers from scattered field measurements is presented. This method is adapted for handling large-scale electromagnetic problems while keeping the memory requirement and the time flexibility as low as possible. The forward scattering problem is solved by applying the finite-element tearing and interconnecting full-dual-primal (FETI-FDP2) method which shares the same spirit as the domain decomposition methods for finite element methods. The idea is to split the computational domain into smaller non-overlapping sub-domains in order to simultaneously solve local sub-problems. Various strategies are proposed in order to efficiently couple the inversion algorithm with the FETI-FDP2 method: a separation into permanent and non-permanent subdomains is performed, iterative solvers are favorized for resolving the interface problem and a marching-on-in-anything initial guess selection further accelerates the process. The computational burden is also reduced by applying the adjoint state vector methodology. Finally, the inversion algorithm is confronted to measurements extracted from the 3D Fresnel database. (paper)

  14. Generalized multiscale finite element method. Symmetric interior penalty coupling

    KAUST Repository

    Efendiev, Yalchin R.; Galvis, Juan; Lazarov, Raytcho D.; Moon, M.; Sarkis, Marcus V.

    2013-01-01

    Motivated by applications to numerical simulations of flows in highly heterogeneous porous media, we develop multiscale finite element methods for second order elliptic equations. We discuss a multiscale model reduction technique in the framework of the discontinuous Galerkin finite element method. We propose two different finite element spaces on the coarse mesh. The first space is based on a local eigenvalue problem that uses an interior weighted L2-norm and a boundary weighted L2-norm for computing the "mass" matrix. The second choice is based on generation of a snapshot space and subsequent selection of a subspace of a reduced dimension. The approximation with these multiscale spaces is based on the discontinuous Galerkin finite element method framework. We investigate the stability and derive error estimates for the methods and further experimentally study their performance on a representative number of numerical examples. © 2013 Elsevier Inc.

  15. Generalized multiscale finite element method. Symmetric interior penalty coupling

    KAUST Repository

    Efendiev, Yalchin R.

    2013-12-01

    Motivated by applications to numerical simulations of flows in highly heterogeneous porous media, we develop multiscale finite element methods for second order elliptic equations. We discuss a multiscale model reduction technique in the framework of the discontinuous Galerkin finite element method. We propose two different finite element spaces on the coarse mesh. The first space is based on a local eigenvalue problem that uses an interior weighted L2-norm and a boundary weighted L2-norm for computing the "mass" matrix. The second choice is based on generation of a snapshot space and subsequent selection of a subspace of a reduced dimension. The approximation with these multiscale spaces is based on the discontinuous Galerkin finite element method framework. We investigate the stability and derive error estimates for the methods and further experimentally study their performance on a representative number of numerical examples. © 2013 Elsevier Inc.

  16. Finite Element Analysis of Circular Plate using SolidWorks

    International Nuclear Information System (INIS)

    Kang, Yeo Jin; Jhung, Myung Jo

    2011-01-01

    Circular plates are used extensively in mechanical engineering for nuclear reactor internal components. The examples in the reactor vessel internals are upper guide structure support plate, fuel alignment plate, lower support plate etc. To verify the structural integrity of these plates, the finite element analyses are performed, which require the development of the finite element model. Sometimes it is very costly and time consuming to make the model especially for the beginners who start their engineering job for the structural analysis, necessitating a simple method to develop the finite element model for the pursuing structural analysis. Therefore in this study, the input decks are generated for the finite element analysis of a circular plate as shown in Fig. 1, which can be used for the structural analysis such as modal analysis, response spectrum analysis, stress analysis, etc using the commercial program Solid Works. The example problems are solved and the results are included for analysts to perform easily the finite element analysis of the mechanical plate components due to various loadings. The various results presented in this study would be helpful not only for the benchmark calculations and results comparisons but also as a part of the knowledge management for the future generation of young designers, scientists and computer analysts

  17. A multiscale mortar multipoint flux mixed finite element method

    KAUST Repository

    Wheeler, Mary Fanett

    2012-02-03

    In this paper, we develop a multiscale mortar multipoint flux mixed finite element method for second order elliptic problems. The equations in the coarse elements (or subdomains) are discretized on a fine grid scale by a multipoint flux mixed finite element method that reduces to cell-centered finite differences on irregular grids. The subdomain grids do not have to match across the interfaces. Continuity of flux between coarse elements is imposed via a mortar finite element space on a coarse grid scale. With an appropriate choice of polynomial degree of the mortar space, we derive optimal order convergence on the fine scale for both the multiscale pressure and velocity, as well as the coarse scale mortar pressure. Some superconvergence results are also derived. The algebraic system is reduced via a non-overlapping domain decomposition to a coarse scale mortar interface problem that is solved using a multiscale flux basis. Numerical experiments are presented to confirm the theory and illustrate the efficiency and flexibility of the method. © EDP Sciences, SMAI, 2012.

  18. Multiscale Universal Interface: A concurrent framework for coupling heterogeneous solvers

    Energy Technology Data Exchange (ETDEWEB)

    Tang, Yu-Hang, E-mail: yuhang_tang@brown.edu [Division of Applied Mathematics, Brown University, Providence, RI (United States); Kudo, Shuhei, E-mail: shuhei-kudo@outlook.jp [Graduate School of System Informatics, Kobe University, 1-1 Rokkodai-cho, Nada-ku, Kobe, 657-8501 (Japan); Bian, Xin, E-mail: xin_bian@brown.edu [Division of Applied Mathematics, Brown University, Providence, RI (United States); Li, Zhen, E-mail: zhen_li@brown.edu [Division of Applied Mathematics, Brown University, Providence, RI (United States); Karniadakis, George Em, E-mail: george_karniadakis@brown.edu [Division of Applied Mathematics, Brown University, Providence, RI (United States); Collaboratory on Mathematics for Mesoscopic Modeling of Materials, Pacific Northwest National Laboratory, Richland, WA 99354 (United States)

    2015-09-15

    Graphical abstract: - Abstract: Concurrently coupled numerical simulations using heterogeneous solvers are powerful tools for modeling multiscale phenomena. However, major modifications to existing codes are often required to enable such simulations, posing significant difficulties in practice. In this paper we present a C++ library, i.e. the Multiscale Universal Interface (MUI), which is capable of facilitating the coupling effort for a wide range of multiscale simulations. The library adopts a header-only form with minimal external dependency and hence can be easily dropped into existing codes. A data sampler concept is introduced, combined with a hybrid dynamic/static typing mechanism, to create an easily customizable framework for solver-independent data interpretation. The library integrates MPI MPMD support and an asynchronous communication protocol to handle inter-solver information exchange irrespective of the solvers' own MPI awareness. Template metaprogramming is heavily employed to simultaneously improve runtime performance and code flexibility. We validated the library by solving three different multiscale problems, which also serve to demonstrate the flexibility of the framework in handling heterogeneous models and solvers. In the first example, a Couette flow was simulated using two concurrently coupled Smoothed Particle Hydrodynamics (SPH) simulations of different spatial resolutions. In the second example, we coupled the deterministic SPH method with the stochastic Dissipative Particle Dynamics (DPD) method to study the effect of surface grafting on the hydrodynamics properties on the surface. In the third example, we consider conjugate heat transfer between a solid domain and a fluid domain by coupling the particle-based energy-conserving DPD (eDPD) method with the Finite Element Method (FEM)

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

  20. finite element model for predicting residual stresses in shielded

    African Journals Online (AJOL)

    eobe

    This paper investigates the prediction of residual stresses developed ... steel plates through Finite Element Model simulation and experiments. ... The experimental values as measured by the X-Ray diffractometer were of ... Based on this, it can be concluded that Finite Element .... Comparison of Residual Stresses from X.

  1. A Finite Element Solution of Lateral Periodic Poisson–Boltzmann Model for Membrane Channel Proteins

    Science.gov (United States)

    Xu, Jingjie; Lu, Benzhuo

    2018-01-01

    Membrane channel proteins control the diffusion of ions across biological membranes. They are closely related to the processes of various organizational mechanisms, such as: cardiac impulse, muscle contraction and hormone secretion. Introducing a membrane region into implicit solvation models extends the ability of the Poisson–Boltzmann (PB) equation to handle membrane proteins. The use of lateral periodic boundary conditions can properly simulate the discrete distribution of membrane proteins on the membrane plane and avoid boundary effects, which are caused by the finite box size in the traditional PB calculations. In this work, we: (1) develop a first finite element solver (FEPB) to solve the PB equation with a two-dimensional periodicity for membrane channel proteins, with different numerical treatments of the singular charges distributions in the channel protein; (2) add the membrane as a dielectric slab in the PB model, and use an improved mesh construction method to automatically identify the membrane channel/pore region even with a tilt angle relative to the z-axis; and (3) add a non-polar solvation energy term to complete the estimation of the total solvation energy of a membrane protein. A mesh resolution of about 0.25 Å (cubic grid space)/0.36 Å (tetrahedron edge length) is found to be most accurate in linear finite element calculation of the PB solvation energy. Computational studies are performed on a few exemplary molecules. The results indicate that all factors, the membrane thickness, the length of periodic box, membrane dielectric constant, pore region dielectric constant, and ionic strength, have individually considerable influence on the solvation energy of a channel protein. This demonstrates the necessity to treat all of those effects in the PB model for membrane protein simulations. PMID:29495644

  2. Finite-Element Modeling of Timber Joints with Punched Metal Plate Fasteners

    DEFF Research Database (Denmark)

    Ellegaard, Peter

    2006-01-01

    The focus of this paper is to describe the idea and the theory behind a finite-element model developed for analysis of timber trusses with punched metal plate fasteners (nail plates). The finite-element model includes the semirigid and nonlinear behavior of the joints (nonlinear nail and plate...... elements) and contact between timber beams, if any (bilinear contact elements). The timber beams have linear-elastic properties. The section forces needed for design of the joints are given directly by the finite-element model, since special elements are used to model the nail groups and the nail plate...... the behavior of the joints very well at lower load levels. At higher load levels the stiffness is overestimated due to development of cracks in the timber and the linear-elastic timber properties in the finite-element model....

  3. Finite element analysis of inelastic structural behavior

    International Nuclear Information System (INIS)

    Argyris, J.H.; Szimmat, J.; Willam, K.J.

    1977-01-01

    The paper describes recent achievements in the finite element analysis of inelastic material behavior. The main purpose is to examine the interaction of three disciplines; (i) the finite element formulation of large deformation problems in the light of a systematic linearization, (ii) the constitutive modelling of inelastic processes in the rate-dependent and rate-independent response regime and (iii) the numerical solution of nonlinear rate problems via incremental iteration techniques. In the first part, alternative finite element models are developed for the idealization of large deformation problems. A systematic approach is presented to linearize the field equations locally by an incremental procedure. The finite element formulation is then examined for the description of inelastic material processes. In the second part, nonlinear and inelastic material phenomena are classified and illustrated with representative examples of concrete and metal components. In particular, rate-dependent and rate-independent material behavior is examined and representative constitutive models are assessed for their mathematical characterization. Hypoelastic, elastoplastic and endochronic models are compared for the description rate-independent material phenomena. In the third part, the numerial solution of inelastic structural behavior is discussed. In this context, several incremental techniques are developed and compared for tracing the evolution of the inelastic process. The numerical procedures are examined with regard to stability and accuracy to assess the overall efficiency. The 'optimal' incremental technique is then contrasted with the computer storage requirements to retain the data for the 'memory-characteristics' of the constitutive model

  4. Numerical experiment on finite element method for matching data

    International Nuclear Information System (INIS)

    Tokuda, Shinji; Kumakura, Toshimasa; Yoshimura, Koichi.

    1993-03-01

    Numerical experiments are presented on the finite element method by Pletzer-Dewar for matching data of an ordinary differential equation with regular singular points by using model equation. Matching data play an important role in nonideal MHD stability analysis of a magnetically confined plasma. In the Pletzer-Dewar method, the Frobenius series for the 'big solution', the fundamental solution which is not square-integrable at the regular singular point, is prescribed. The experiments include studies of the convergence rate of the matching data obtained by the finite element method and of the effect on the results of computation by truncating the Frobenius series at finite terms. It is shown from the present study that the finite element method is an effective method for obtaining the matching data with high accuracy. (author)

  5. Analytical and finite element modeling of grounding systems

    Energy Technology Data Exchange (ETDEWEB)

    Luz, Mauricio Valencia Ferreira da [University of Santa Catarina (UFSC), Florianopolis, SC (Brazil)], E-mail: mauricio@grucad.ufsc.br; Dular, Patrick [University of Liege (Belgium). Institut Montefiore], E-mail: Patrick.Dular@ulg.ac.be

    2007-07-01

    Grounding is the art of making an electrical connection to the earth. This paper deals with the analytical and finite element modeling of grounding systems. An electrokinetic formulation using a scalar potential can benefit from floating potentials to define global quantities such as electric voltages and currents. The application concerns a single vertical grounding with one, two and three-layer soil, where the superior extremity stays in the surface of the soil. This problem has been modeled using a 2D axi-symmetric electrokinetic formulation. The grounding resistance obtained by finite element method is compared with the analytical one for one-layer soil. With the results of this paper it is possible to show that finite element method is a powerful tool in the analysis of the grounding systems in low frequencies. (author)

  6. Robust mixed finite element methods to deal with incompressibility in finite strain in an industrial framework

    International Nuclear Information System (INIS)

    Al-Akhrass, Dina

    2014-01-01

    Simulations in solid mechanics exhibit several difficulties, as dealing with incompressibility, with nonlinearities due to finite strains, contact laws, or constitutive laws. The basic motivation of our work is to propose efficient finite element methods capable of dealing with incompressibility in finite strain context, and using elements of low order. During the three last decades, many approaches have been proposed in the literature to overcome the incompressibility problem. Among them, mixed formulations offer an interesting theoretical framework. In this work, a three-field mixed formulation (displacement, pressure, volumetric strain) is investigated. In some cases, this formulation can be condensed in a two-field (displacement - pressure) mixed formulation. However, it is well-known that the discrete problem given by the Galerkin finite element technique, does not inherit the 'inf-sup' stability condition from the continuous problem. Hence, the interpolation orders in displacement and pressure have to be chosen in a way to satisfy the Brezzi-Babuska stability conditions when using Galerkin approaches. Interpolation orders must be chosen so as to satisfy this condition. Two possibilities are considered: to use stable finite element satisfying this requirement, or to use finite element that does not satisfy this condition, and to add terms stabilizing the FE Galerkin formulation. The latter approach allows the use of equal order interpolation. In this work, stable finite element P2/P1 and P2/P1/P1 are used as reference, and compared to P1/P1 and P1/P1/P1 formulations stabilized with a bubble function or with a VMS method (Variational Multi-Scale) based on a sub-grid-space orthogonal to the FE space. A finite strain model based on logarithmic strain is selected. This approach is extended to three and two field mixed formulations with stable or stabilized elements. These approaches are validated on academic cases and used on industrial cases. (author)

  7. Non-Linear Three Dimensional Finite Elements for Composite Concrete Structures

    Directory of Open Access Journals (Sweden)

    O. Kohnehpooshi

    Full Text Available Abstract The current investigation focused on the development of effective and suitable modelling of reinforced concrete component with and without strengthening. The modelling includes physical and constitutive models. New interface elements have been developed, while modified constitutive law have been applied and new computational algorithm is utilised. The new elements are the Truss-link element to model the interaction between concrete and reinforcement bars, the interface element between two plate bending elements and the interface element to represent the interfacial behaviour between FRP, steel plates and concrete. Nonlinear finite-element (FE codes were developed with pre-processing. The programme was written using FORTRAN language. The accuracy and efficiency of the finite element programme were achieved by analyzing several examples from the literature. The application of the 3D FE code was further enhanced by carrying out the numerical analysis of the three dimensional finite element analysis of FRP strengthened RC beams, as well as the 3D non-linear finite element analysis of girder bridge. Acceptable distributions of slip, deflection, stresses in the concrete and FRP plate have also been found. These results show that the new elements are effective and appropriate to be used for structural component modelling.

  8. ZONE: a finite element mesh generator

    International Nuclear Information System (INIS)

    Burger, M.J.

    1976-05-01

    The ZONE computer program is a finite-element mesh generator which produces the nodes and element description of any two-dimensional geometry. The geometry is subdivided into a mesh of quadrilateral and triangular zones arranged sequentially in an ordered march through the geometry. The order of march can be chosen so that the minimum bandwidth is obtained. The node points are defined in terms of the x and y coordinates in a global rectangular coordinate system. The zones generated are quadrilaterals or triangles defined by four node points in a counterclockwise sequence. Node points defining the outside boundary are generated to describe pressure boundary conditions. The mesh that is generated can be used as input to any two-dimensional as well as any axisymmetrical structure program. The output from ZONE is essentially the input file to NAOS, HONDO, and other axisymmetric finite element programs. 14 figures

  9. Finite elements methods in mechanics

    CERN Document Server

    Eslami, M Reza

    2014-01-01

    This book covers all basic areas of mechanical engineering, such as fluid mechanics, heat conduction, beams, and elasticity with detailed derivations for the mass, stiffness, and force matrices. It is especially designed to give physical feeling to the reader for finite element approximation by the introduction of finite elements to the elevation of elastic membrane. A detailed treatment of computer methods with numerical examples are provided. In the fluid mechanics chapter, the conventional and vorticity transport formulations for viscous incompressible fluid flow with discussion on the method of solution are presented. The variational and Galerkin formulations of the heat conduction, beams, and elasticity problems are also discussed in detail. Three computer codes are provided to solve the elastic membrane problem. One of them solves the Poisson’s equation. The second computer program handles the two dimensional elasticity problems, and the third one presents the three dimensional transient heat conducti...

  10. An angularly refineable phase space finite element method with approximate sweeping procedure

    International Nuclear Information System (INIS)

    Kophazi, J.; Lathouwers, D.

    2013-01-01

    An angularly refineable phase space finite element method is proposed to solve the neutron transport equation. The method combines the advantages of two recently published schemes. The angular domain is discretized into small patches and patch-wise discontinuous angular basis functions are restricted to these patches, i.e. there is no overlap between basis functions corresponding to different patches. This approach yields block diagonal Jacobians with small block size and retains the possibility for S n -like approximate sweeping of the spatially discontinuous elements in order to provide efficient preconditioners for the solution procedure. On the other hand, the preservation of the full FEM framework (as opposed to collocation into a high-order S n scheme) retains the possibility of the Galerkin interpolated connection between phase space elements at arbitrary levels of discretization. Since the basis vectors are not orthonormal, a generalization of the Riemann procedure is introduced to separate the incoming and outgoing contributions in case of unstructured meshes. However, due to the properties of the angular discretization, the Riemann procedure can be avoided at a large fraction of the faces and this fraction rapidly increases as the level of refinement increases, contributing to the computational efficiency. In this paper the properties of the discretization scheme are studied with uniform refinement using an iterative solver based on the S 2 sweep order of the spatial elements. The fourth order convergence of the scalar flux is shown as anticipated from earlier schemes and the rapidly decreasing fraction of required Riemann faces is illustrated. (authors)

  11. A finite element conjugate gradient FFT method for scattering

    Science.gov (United States)

    Collins, Jeffery D.; Ross, Dan; Jin, J.-M.; Chatterjee, A.; Volakis, John L.

    1991-01-01

    Validated results are presented for the new 3D body of revolution finite element boundary integral code. A Fourier series expansion of the vector electric and mangnetic fields is employed to reduce the dimensionality of the system, and the exact boundary condition is employed to terminate the finite element mesh. The mesh termination boundary is chosen such that is leads to convolutional boundary operatores of low O(n) memory demand. Improvements of this code are discussed along with the proposed formulation for a full 3D implementation of the finite element boundary integral method in conjunction with a conjugate gradiant fast Fourier transformation (CGFFT) solution.

  12. SEACAS Theory Manuals: Part III. Finite Element Analysis in Nonlinear Solid Mechanics

    Energy Technology Data Exchange (ETDEWEB)

    Laursen, T.A.; Attaway, S.W.; Zadoks, R.I.

    1999-03-01

    This report outlines the application of finite element methodology to large deformation solid mechanics problems, detailing also some of the key technological issues that effective finite element formulations must address. The presentation is organized into three major portions: first, a discussion of finite element discretization from the global point of view, emphasizing the relationship between a virtual work principle and the associated fully discrete system, second, a discussion of finite element technology, emphasizing the important theoretical and practical features associated with an individual finite element; and third, detailed description of specific elements that enjoy widespread use, providing some examples of the theoretical ideas already described. Descriptions of problem formulation in nonlinear solid mechanics, nonlinear continuum mechanics, and constitutive modeling are given in three companion reports.

  13. Application of hexagonal element scheme in finite element method to three-dimensional diffusion problem of fast reactors

    International Nuclear Information System (INIS)

    Ishiguro, Misako; Higuchi, Kenji

    1983-01-01

    The finite element method is applied in Galerkin-type approximation to three-dimensional neutron diffusion equations of fast reactors. A hexagonal element scheme is adopted for treating the hexagonal lattice which is typical for fast reactors. The validity of the scheme is verified by applying the scheme as well as alternative schemes to the neutron diffusion calculation of a gas-cooled fast reactor of actual scale. The computed results are compared with corresponding values obtained using the currently applied triangular-element and also with conventional finite difference schemes. The hexagonal finite element scheme is found to yield a reasonable solution to the problem taken up here, with some merit in terms of saving in computing time, but the resulting multiplication factor differs by 1% and the flux by 9% compared with the triangular mesh finite difference scheme. The finite element method, even in triangular element scheme, would appear to incur error in inadmissible amount and which could not be easily eliminated by refining the nodes. (author)

  14. Navier-Stokes calculations on multi-element airfoils using a chimera-based solver

    Science.gov (United States)

    Jasper, Donald W.; Agrawal, Shreekant; Robinson, Brian A.

    1993-01-01

    A study of Navier-Stokes calculations of flows about multielement airfoils using a chimera grid approach is presented. The chimera approach utilizes structured, overlapped grids which allow great flexibility of grid arrangement and simplifies grid generation. Calculations are made for two-, three-, and four-element airfoils, and modeling of the effect of gap distance between elements is demonstrated for a two element case. Solutions are obtained using the thin-layer form of the Reynolds averaged Navier-Stokes equations with turbulence closure provided by the Baldwin-Lomax algebraic model or the Baldwin-Barth one equation model. The Baldwin-Barth turbulence model is shown to provide better agreement with experimental data and to dramatically improve convergence rates for some cases. Recently developed, improved farfield boundary conditions are incorporated into the solver for greater efficiency. Computed results show good comparison with experimental data which include aerodynamic forces, surface pressures, and boundary layer velocity profiles.

  15. Finite element approximation to the even-parity transport equation

    International Nuclear Information System (INIS)

    Lewis, E.E.

    1981-01-01

    This paper studies the finite element method, a procedure for reducing partial differential equations to sets of algebraic equations suitable for solution on a digital computer. The differential equation is cast into the form of a variational principle, the resulting domain then subdivided into finite elements. The dependent variable is then approximated by a simple polynomial, and these are linked across inter-element boundaries by continuity conditions. The finite element method is tailored to a variety of transport problems. Angular approximations are formulated, and the extent of ray effect mitigation is examined. Complex trial functions are introduced to enable the inclusion of buckling approximations. The ubiquitous curved interfaces of cell calculations, and coarse mesh methods are also treated. A concluding section discusses limitations of the work to date and suggests possible future directions

  16. Linear finite element method for one-dimensional diffusion problems

    Energy Technology Data Exchange (ETDEWEB)

    Brandao, Michele A.; Dominguez, Dany S.; Iglesias, Susana M., E-mail: micheleabrandao@gmail.com, E-mail: dany@labbi.uesc.br, E-mail: smiglesias@uesc.br [Universidade Estadual de Santa Cruz (LCC/DCET/UESC), Ilheus, BA (Brazil). Departamento de Ciencias Exatas e Tecnologicas. Laboratorio de Computacao Cientifica

    2011-07-01

    We describe in this paper the fundamentals of Linear Finite Element Method (LFEM) applied to one-speed diffusion problems in slab geometry. We present the mathematical formulation to solve eigenvalue and fixed source problems. First, we discretized a calculus domain using a finite set of elements. At this point, we obtain the spatial balance equations for zero order and first order spatial moments inside each element. Then, we introduce the linear auxiliary equations to approximate neutron flux and current inside the element and architect a numerical scheme to obtain the solution. We offer numerical results for fixed source typical model problems to illustrate the method's accuracy for coarse-mesh calculations in homogeneous and heterogeneous domains. Also, we compare the accuracy and computational performance of LFEM formulation with conventional Finite Difference Method (FDM). (author)

  17. Finite-difference method Stokes solver (FDMSS) for 3D pore geometries: Software development, validation and case studies

    Science.gov (United States)

    Gerke, Kirill M.; Vasilyev, Roman V.; Khirevich, Siarhei; Collins, Daniel; Karsanina, Marina V.; Sizonenko, Timofey O.; Korost, Dmitry V.; Lamontagne, Sébastien; Mallants, Dirk

    2018-05-01

    Permeability is one of the fundamental properties of porous media and is required for large-scale Darcian fluid flow and mass transport models. Whilst permeability can be measured directly at a range of scales, there are increasing opportunities to evaluate permeability from pore-scale fluid flow simulations. We introduce the free software Finite-Difference Method Stokes Solver (FDMSS) that solves Stokes equation using a finite-difference method (FDM) directly on voxelized 3D pore geometries (i.e. without meshing). Based on explicit convergence studies, validation on sphere packings with analytically known permeabilities, and comparison against lattice-Boltzmann and other published FDM studies, we conclude that FDMSS provides a computationally efficient and accurate basis for single-phase pore-scale flow simulations. By implementing an efficient parallelization and code optimization scheme, permeability inferences can now be made from 3D images of up to 109 voxels using modern desktop computers. Case studies demonstrate the broad applicability of the FDMSS software for both natural and artificial porous media.

  18. Finite-difference method Stokes solver (FDMSS) for 3D pore geometries: Software development, validation and case studies

    KAUST Repository

    Gerke, Kirill M.

    2018-01-17

    Permeability is one of the fundamental properties of porous media and is required for large-scale Darcian fluid flow and mass transport models. Whilst permeability can be measured directly at a range of scales, there are increasing opportunities to evaluate permeability from pore-scale fluid flow simulations. We introduce the free software Finite-Difference Method Stokes Solver (FDMSS) that solves Stokes equation using a finite-difference method (FDM) directly on voxelized 3D pore geometries (i.e. without meshing). Based on explicit convergence studies, validation on sphere packings with analytically known permeabilities, and comparison against lattice-Boltzmann and other published FDM studies, we conclude that FDMSS provides a computationally efficient and accurate basis for single-phase pore-scale flow simulations. By implementing an efficient parallelization and code optimization scheme, permeability inferences can now be made from 3D images of up to 109 voxels using modern desktop computers. Case studies demonstrate the broad applicability of the FDMSS software for both natural and artificial porous media.

  19. Quadrature representation of finite element variational forms

    DEFF Research Database (Denmark)

    Ølgaard, Kristian Breum; Wells, Garth N.

    2012-01-01

    This chapter addresses the conventional run-time quadrature approach for the numerical integration of local element tensors associated with finite element variational forms, and in particular automated optimizations that can be performed to reduce the number of floating point operations...

  20. Development of a partitioned finite volume-finite element fluid-structure interaction scheme for strongly-coupled problems

    CSIR Research Space (South Africa)

    Suliman, Ridhwaan

    2012-07-01

    Full Text Available -linear deformations are accounted for. As will be demonstrated, the finite volume approach exhibits similar disad- vantages to the linear Q4 finite element formulation when undergoing bending. An enhanced finite volume approach is discussed and compared with finite...

  1. A finite element thermohydrodynamic analyis of profile bore bearing

    International Nuclear Information System (INIS)

    Shah Nor bin Basri

    1994-01-01

    A finite element-based method is presented for analysing the thermohydrodynamic (THD) behaviour of profile bore bearing. A variational statement for the governing equation is derived and used to formulate a non-linear quadrilateral finite element of serendipity family. The predicted behaviour is compared with experimental evidence where possible and favorable correlation is obtained

  2. Hualien forced vibration calculation with a finite element model

    International Nuclear Information System (INIS)

    Wang, F.; Gantenbein, F.; Nedelec, M.; Duretz, Ch.

    1995-01-01

    The forced vibration tests of the Hualien mock-up were useful to validate finite element models developed for soil-structure interaction. In this paper the two sets of tests with and without backfill were analysed. the methods used are based on finite element modeling for the soil. Two approaches were considered: calculation of soil impedance followed by the calculation of the transfer functions with a model taking into account the superstructure and the impedance; direct calculation of the soil-structure transfer functions, with the soil and the structure being represented in the same model by finite elements. Blind predictions and post-test calculations are presented and compared with the test results. (author). 4 refs., 8 figs., 2 tabs

  3. The Finite Element Numerical Modelling of 3D Magnetotelluric

    Directory of Open Access Journals (Sweden)

    Ligang Cao

    2014-01-01

    Full Text Available The ideal numerical simulation of 3D magnetotelluric was restricted by the methodology complexity and the time-consuming calculation. Boundary values, the variation of weighted residual equation, and the hexahedral mesh generation method of finite element are three major causes. A finite element method for 3D magnetotelluric numerical modeling is presented in this paper as a solution for the problem mentioned above. In this algorithm, a hexahedral element coefficient matrix for magnetoelluric finite method is developed, which solves large-scale equations using preconditioned conjugate gradient of the first-type boundary conditions. This algorithm is verified using the homogeneous model, and the positive landform model, as well as the low resistance anomaly model.

  4. Bubble-Enriched Least-Squares Finite Element Method for Transient Advective Transport

    Directory of Open Access Journals (Sweden)

    Rajeev Kumar

    2008-01-01

    Full Text Available The least-squares finite element method (LSFEM has received increasing attention in recent years due to advantages over the Galerkin finite element method (GFEM. The method leads to a minimization problem in the L2-norm and thus results in a symmetric and positive definite matrix, even for first-order differential equations. In addition, the method contains an implicit streamline upwinding mechanism that prevents the appearance of oscillations that are characteristic of the Galerkin method. Thus, the least-squares approach does not require explicit stabilization and the associated stabilization parameters required by the Galerkin method. A new approach, the bubble enriched least-squares finite element method (BELSFEM, is presented and compared with the classical LSFEM. The BELSFEM requires a space-time element formulation and employs bubble functions in space and time to increase the accuracy of the finite element solution without degrading computational performance. We apply the BELSFEM and classical least-squares finite element methods to benchmark problems for 1D and 2D linear transport. The accuracy and performance are compared.

  5. Finite element model updating of concrete structures based on imprecise probability

    Science.gov (United States)

    Biswal, S.; Ramaswamy, A.

    2017-09-01

    Imprecise probability based methods are developed in this study for the parameter estimation, in finite element model updating for concrete structures, when the measurements are imprecisely defined. Bayesian analysis using Metropolis Hastings algorithm for parameter estimation is generalized to incorporate the imprecision present in the prior distribution, in the likelihood function, and in the measured responses. Three different cases are considered (i) imprecision is present in the prior distribution and in the measurements only, (ii) imprecision is present in the parameters of the finite element model and in the measurement only, and (iii) imprecision is present in the prior distribution, in the parameters of the finite element model, and in the measurements. Procedures are also developed for integrating the imprecision in the parameters of the finite element model, in the finite element software Abaqus. The proposed methods are then verified against reinforced concrete beams and prestressed concrete beams tested in our laboratory as part of this study.

  6. A modal-based reduction method for sound absorbing porous materials in poro-acoustic finite element models.

    Science.gov (United States)

    Rumpler, Romain; Deü, Jean-François; Göransson, Peter

    2012-11-01

    Structural-acoustic finite element models including three-dimensional (3D) modeling of porous media are generally computationally costly. While being the most commonly used predictive tool in the context of noise reduction applications, efficient solution strategies are required. In this work, an original modal reduction technique, involving real-valued modes computed from a classical eigenvalue solver is proposed to reduce the size of the problem associated with the porous media. In the form presented in this contribution, the method is suited for homogeneous porous layers. It is validated on a 1D poro-acoustic academic problem and tested for its performance on a 3D application, using a subdomain decomposition strategy. The performance of the proposed method is estimated in terms of degrees of freedom downsizing, computational time enhancement, as well as matrix sparsity of the reduced system.

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

    Science.gov (United States)

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

    2017-01-01

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

  8. A three-dimensional cell-based smoothed finite element method for elasto-plasticity

    International Nuclear Information System (INIS)

    Lee, Kye Hyung; Im, Se Yong; Lim, Jae Hyuk; Sohn, Dong Woo

    2015-01-01

    This work is concerned with a three-dimensional cell-based smoothed finite element method for application to elastic-plastic analysis. The formulation of smoothed finite elements is extended to cover elastic-plastic deformations beyond the classical linear theory of elasticity, which has been the major application domain of smoothed finite elements. The finite strain deformations are treated with the aid of the formulation based on the hyperelastic constitutive equation. The volumetric locking originating from the nearly incompressible behavior of elastic-plastic deformations is remedied by relaxing the volumetric strain through the mean value. The comparison with the conventional finite elements demonstrates the effectiveness and accuracy of the present approach.

  9. A three-dimensional cell-based smoothed finite element method for elasto-plasticity

    Energy Technology Data Exchange (ETDEWEB)

    Lee, Kye Hyung; Im, Se Yong [KAIST, Daejeon (Korea, Republic of); Lim, Jae Hyuk [KARI, Daejeon (Korea, Republic of); Sohn, Dong Woo [Korea Maritime and Ocean University, Busan (Korea, Republic of)

    2015-02-15

    This work is concerned with a three-dimensional cell-based smoothed finite element method for application to elastic-plastic analysis. The formulation of smoothed finite elements is extended to cover elastic-plastic deformations beyond the classical linear theory of elasticity, which has been the major application domain of smoothed finite elements. The finite strain deformations are treated with the aid of the formulation based on the hyperelastic constitutive equation. The volumetric locking originating from the nearly incompressible behavior of elastic-plastic deformations is remedied by relaxing the volumetric strain through the mean value. The comparison with the conventional finite elements demonstrates the effectiveness and accuracy of the present approach.

  10. On Using Particle Finite Element for Hydrodynamics Problems Solving

    Directory of Open Access Journals (Sweden)

    E. V. Davidova

    2015-01-01

    Full Text Available The aim of the present research is to develop software for the Particle Finite Element Method (PFEM and its verification on the model problem of viscous incompressible flow simulation in a square cavity. The Lagrangian description of the medium motion is used: the nodes of the finite element mesh move together with the fluid that allows to consider them as particles of the medium. Mesh cells deform when in time-stepping procedure, so it is necessary to reconstruct the mesh to provide stability of the finite element numerical procedure.Meshing algorithm allows us to obtain the mesh, which satisfies the Delaunay criteria: it is called \\the possible triangles method". This algorithm is based on the well-known Fortune method of Voronoi diagram constructing for a certain set of points in the plane. The graphical representation of the possible triangles method is shown. It is suitable to use generalization of Delaunay triangulation in order to construct meshes with polygonal cells in case of multiple nodes close to be lying on the same circle.The viscous incompressible fluid flow is described by the Navier | Stokes equations and the mass conservation equation with certain initial and boundary conditions. A fractional steps method, which allows us to avoid non-physical oscillations of the pressure, provides the timestepping procedure. Using the finite element discretization and the Bubnov | Galerkin method allows us to carry out spatial discretization.For form functions calculation of finite element mesh with polygonal cells, \

  11. Predicting the response of high damping rubber bearings using simplified models and finite element analysis

    International Nuclear Information System (INIS)

    Fuller, K.N.G.; Gough, J.; Ahmadi, H.R.

    1993-01-01

    The International Atomic Energy Agency has initiated a co-ordinated research programme on implementation of base-isolation for nuclear structures. This paper discusses two areas relevant to modelling elastomeric base-isolators. These are the use of simplified models to predict the response of isolated structures to earthquake inputs and finite element analysis for calculating the stress distributions within the isolators. In the former, a curvilinear hysteretic model of the high damping natural rubber able to accommodate the stiffening of the rubber at large shear deflections is presented. Its predictions of structural accelerations and bearing displacement produced by design earthquakes and those above the design level are compared with those using a linear spring and dashpot model. A comparison has been made between two finite element analyses using MARC and ABAQUS of the force-deformation behaviour of a single disc of rubber bonded on both sides. The disc was loaded both in compression and shear. Two forms of strain energy functions were used namely Mooney-RivIin and Ogden. The agreement between MARC and ABAQUS for the Mooney-Rivlin model for the material was very good. This was not however the case for the Ogden model and a difference of 25% in the maximum vertical deflection of the disc under 200kN load was observed. The need for a 'benchmark' problem is identified. This could be used to establish the accuracy of the finite element solvers. A problem based on the work of Rivlin on the force-deformation behaviour of cylinder of rubber under torsion is nominated. An appraisal of strain energy functions based on Mooney-RivIin formulations is carried out. It is shown that even for a five term series the strain energy function is incapable of catering for the rapid change of modulus at small strains both for simple and pure shear modes of deformation. This function models tension/compression data much better. The work identifies the need for evaluating other forms

  12. FINITE ELEMENT ANALYSIS OF ELEMENT ANALYSIS OF A FREE ...

    African Journals Online (AJOL)

    eobe

    the stairs and to compare the finite element ana ... tual three dimensional behavior of the stair slab system. ..... due to its close relation of output with the propo .... flights. It is best not to consider any open well when .... thermodynamics of solids.

  13. A fast linearized conservative finite element method for the strongly coupled nonlinear fractional Schrödinger equations

    Science.gov (United States)

    Li, Meng; Gu, Xian-Ming; Huang, Chengming; Fei, Mingfa; Zhang, Guoyu

    2018-04-01

    In this paper, a fast linearized conservative finite element method is studied for solving the strongly coupled nonlinear fractional Schrödinger equations. We prove that the scheme preserves both the mass and energy, which are defined by virtue of some recursion relationships. Using the Sobolev inequalities and then employing the mathematical induction, the discrete scheme is proved to be unconditionally convergent in the sense of L2-norm and H α / 2-norm, which means that there are no any constraints on the grid ratios. Then, the prior bound of the discrete solution in L2-norm and L∞-norm are also obtained. Moreover, we propose an iterative algorithm, by which the coefficient matrix is independent of the time level, and thus it leads to Toeplitz-like linear systems that can be efficiently solved by Krylov subspace solvers with circulant preconditioners. This method can reduce the memory requirement of the proposed linearized finite element scheme from O (M2) to O (M) and the computational complexity from O (M3) to O (Mlog ⁡ M) in each iterative step, where M is the number of grid nodes. Finally, numerical results are carried out to verify the correction of the theoretical analysis, simulate the collision of two solitary waves, and show the utility of the fast numerical solution techniques.

  14. Nonlinear Legendre Spectral Finite Elements for Wind Turbine Blade Dynamics: Preprint

    Energy Technology Data Exchange (ETDEWEB)

    Wang, Q.; Sprague, M. A.; Jonkman, J.; Johnson, N.

    2014-01-01

    This paper presents a numerical implementation and examination of new wind turbine blade finite element model based on Geometrically Exact Beam Theory (GEBT) and a high-order spectral finite element method. The displacement-based GEBT is presented, which includes the coupling effects that exist in composite structures and geometric nonlinearity. Legendre spectral finite elements (LSFEs) are high-order finite elements with nodes located at the Gauss-Legendre-Lobatto points. LSFEs can be an order of magnitude more efficient that low-order finite elements for a given accuracy level. Interpolation of the three-dimensional rotation, a major technical barrier in large-deformation simulation, is discussed in the context of LSFEs. It is shown, by numerical example, that the high-order LSFEs, where weak forms are evaluated with nodal quadrature, do not suffer from a drawback that exists in low-order finite elements where the tangent-stiffness matrix is calculated at the Gauss points. Finally, the new LSFE code is implemented in the new FAST Modularization Framework for dynamic simulation of highly flexible composite-material wind turbine blades. The framework allows for fully interactive simulations of turbine blades in operating conditions. Numerical examples showing validation and LSFE performance will be provided in the final paper.

  15. Finite element simulations of two rock mechanics tests

    International Nuclear Information System (INIS)

    Dahlke, H.J.; Lott, S.A.

    1986-04-01

    Rock mechanics tests are performed to determine in situ stress conditions and material properties of an underground rock mass. To design stable underground facilities for the permanent storage of high-level nuclear waste, determination of these properties and conditions is a necessary first step. However, before a test and its associated equipment can be designed, the engineer needs to know the range of expected values to be measured by the instruments. Sensitivity studies by means of finite element simulations are employed in this preliminary design phase to evaluate the pertinent parameters and their effects on the proposed measurements. The simulations, of two typical rock mechanics tests, the plate bearing test and the flat-jack test, by means of the finite element analysis, are described. The plate bearing test is used to determine the rock mass deformation modulus. The flat-jack test is used to determine the in situ stress conditions of the host rock. For the plate bearing test, two finite element models are used to simulate the classic problem of a load on an elastic half space and the actual problem of a plate bearing test in an underground tunnel of circular cross section. For the flat-jack simulation, a single finite element model is used to simulate both horizontal and vertical slots. Results will be compared to closed-form solutions available in the literature

  16. A simple finite element method for linear hyperbolic problems

    International Nuclear Information System (INIS)

    Mu, Lin; Ye, Xiu

    2017-01-01

    Here, we introduce a simple finite element method for solving first order hyperbolic equations with easy implementation and analysis. Our new method, with a symmetric, positive definite system, is designed to use discontinuous approximations on finite element partitions consisting of arbitrary shape of polygons/polyhedra. Error estimate is established. Extensive numerical examples are tested that demonstrate the robustness and flexibility of the method.

  17. Finite element computation of plasma equilibria

    International Nuclear Information System (INIS)

    Rivier, M.

    1977-01-01

    The applicability of the finite element method is investigated for the numerical solution of the nonlinear Grad-Shafranov equation with free boundary for the flux function of a plasma at equilibrium. This method is based on the case of variational principles and finite dimensional subspaces whose elements are piecewise polynomial functions obtained by a Lagrange type interpolation procedure over a triangulation of the domain. Two cases of plasma pressure (exponential and quadratic including a vacuum region) were examined. In both cases the nonuniqueness of the solutions was shown in exhibiting a deeper solution in the case of exponential pressure function, and a non-constant solution for a quadratic pressure function. In order to get this ''other'' solution, two linearization methods were tested with two different constraints. Different cross sections are investigated

  18. Flow Applications of the Least Squares Finite Element Method

    Science.gov (United States)

    Jiang, Bo-Nan

    1998-01-01

    The main thrust of the effort has been towards the development, analysis and implementation of the least-squares finite element method (LSFEM) for fluid dynamics and electromagnetics applications. In the past year, there were four major accomplishments: 1) special treatments in computational fluid dynamics and computational electromagnetics, such as upwinding, numerical dissipation, staggered grid, non-equal order elements, operator splitting and preconditioning, edge elements, and vector potential are unnecessary; 2) the analysis of the LSFEM for most partial differential equations can be based on the bounded inverse theorem; 3) the finite difference and finite volume algorithms solve only two Maxwell equations and ignore the divergence equations; and 4) the first numerical simulation of three-dimensional Marangoni-Benard convection was performed using the LSFEM.

  19. Investigation of Shear Stud Performance in Flat Plate Using Finite Element Analysis

    Directory of Open Access Journals (Sweden)

    T.S. Viswanathan

    2014-09-01

    Full Text Available Three types of shear stud arrangement, respectively featuring an orthogonal, a radial and a critical perimeter pattern, were evaluated numerically. A numerical investigation was conducted using the finite element software ABAQUS to evaluate their ability to resist punching shear in a flat plate. The finite element analysis here is an application of the nonlinear analysis of reinforced concrete structures using three-dimensional solid finite elements. The nonlinear characteristics of concrete were achieved by employing the concrete damaged plasticity model in the finite element program. Transverse shear stress was evaluated using finite element analysis in terms of shear stress distribution for flat plate with and without shear stud reinforcement. The model predicted that shear studs placed along the critical perimeter are more effective compared to orthogonal and radial patterns.

  20. Aspects of Finite Element Simulation of Axi-Symmetric Hydromechanical Deep Drawing

    DEFF Research Database (Denmark)

    Jensen, Morten Rikard; Olovsson, Lars; Danckert, Joachim

    1999-01-01

    A new approach for the Finite Element modelling of the hydromechanical deep drawing process is evaluated. In the model a Finite Difference approximation of Reynold’s equation is solved for the fluid flow between the blank and the draw die in the flange region. The approach is implemented...... as a contact algorithm in an explicit Finite Element code, Exhale2D. The developed model is verified against experiments and good agreement is obtained. It is concluded that the developed model is a promising approach for simulating the hydromechanical deep drawing process using the Finite Element Method....

  1. High-Order Curvilinear Finite Element Methods for Lagrangian Hydrodynamics [High Order Curvilinear Finite Elements for Lagrangian Hydrodynamics

    Energy Technology Data Exchange (ETDEWEB)

    Dobrev, Veselin A. [Lawrence Livermore National Lab. (LLNL), Livermore, CA (United States); Kolev, Tzanio V. [Lawrence Livermore National Lab. (LLNL), Livermore, CA (United States); Rieben, Robert N. [Lawrence Livermore National Lab. (LLNL), Livermore, CA (United States)

    2012-09-20

    The numerical approximation of the Euler equations of gas dynamics in a movingLagrangian frame is at the heart of many multiphysics simulation algorithms. Here, we present a general framework for high-order Lagrangian discretization of these compressible shock hydrodynamics equations using curvilinear finite elements. This method is an extension of the approach outlined in [Dobrev et al., Internat. J. Numer. Methods Fluids, 65 (2010), pp. 1295--1310] and can be formulated for any finite dimensional approximation of the kinematic and thermodynamic fields, including generic finite elements on two- and three-dimensional meshes with triangular, quadrilateral, tetrahedral, or hexahedral zones. We discretize the kinematic variables of position and velocity using a continuous high-order basis function expansion of arbitrary polynomial degree which is obtained via a corresponding high-order parametric mapping from a standard reference element. This enables the use of curvilinear zone geometry, higher-order approximations for fields within a zone, and a pointwise definition of mass conservation which we refer to as strong mass conservation. Moreover, we discretize the internal energy using a piecewise discontinuous high-order basis function expansion which is also of arbitrary polynomial degree. This facilitates multimaterial hydrodynamics by treating material properties, such as equations of state and constitutive models, as piecewise discontinuous functions which vary within a zone. To satisfy the Rankine--Hugoniot jump conditions at a shock boundary and generate the appropriate entropy, we introduce a general tensor artificial viscosity which takes advantage of the high-order kinematic and thermodynamic information available in each zone. Finally, we apply a generic high-order time discretization process to the semidiscrete equations to develop the fully discrete numerical algorithm. Our method can be viewed as the high-order generalization of the so-called staggered

  2. A General Finite Element Scheme for Limit State Analysis and Optimization

    DEFF Research Database (Denmark)

    Damkilde, Lars

    1999-01-01

    Limit State analysis which is based on a perfect material behaviour is used in many different applications primarily within Structural Engineering and Geotechnics. The calculation methods have not reached the same level of automation such as Finite Element Analysis for elastic structures....... The computer based systems are more ad hoc based and are typically not well-integrated with pre- and postprocessors well-known from commercial Finite Element codes.A finite element based formulation of limit state analysis is presented which allows an easy integration with standard Finite Element codes...... for elastic analysis. In this way the user is able to perform a limit state analysis on the same model used for elastic analysis only adding data for the yield surface.The method is based on the lower-bound theorem and uses stress-based elements with a linearized yield surface. The mathematical problem...

  3. Finite element modeling of piezoelectric elements with complex electrode configuration

    International Nuclear Information System (INIS)

    Paradies, R; Schläpfer, B

    2009-01-01

    It is well known that the material properties of piezoelectric materials strongly depend on the state of polarization of the individual element. While an unpolarized material exhibits mechanically isotropic material properties in the absence of global piezoelectric capabilities, the piezoelectric material properties become transversally isotropic with respect to the polarization direction after polarization. Therefore, for evaluating piezoelectric elements the material properties, including the coupling between the mechanical and the electromechanical behavior, should be addressed correctly. This is of special importance for the micromechanical description of piezoelectric elements with interdigitated electrodes (IDEs). The best known representatives of this group are active fiber composites (AFCs), macro fiber composites (MFCs) and the radial field diaphragm (RFD), respectively. While the material properties are available for a piezoelectric wafer with a homogeneous polarization perpendicular to its plane as postulated in the so-called uniform field model (UFM), the same information is missing for piezoelectric elements with more complex electrode configurations like the above-mentioned ones with IDEs. This is due to the inhomogeneous field distribution which does not automatically allow for the correct assignment of the material, i.e. orientation and property. A variation of the material orientation as well as the material properties can be accomplished by including the polarization process of the piezoelectric transducer in the finite element (FE) simulation prior to the actual load case to be investigated. A corresponding procedure is presented which automatically assigns the piezoelectric material properties, e.g. elasticity matrix, permittivity, and charge vector, for finite element models (FEMs) describing piezoelectric transducers according to the electric field distribution (field orientation and strength) in the structure. A corresponding code has been

  4. Engineering computation of structures the finite element method

    CERN Document Server

    Neto, Maria Augusta; Roseiro, Luis; Cirne, José; Leal, Rogério

    2015-01-01

    This book presents theories and the main useful techniques of the Finite Element Method (FEM), with an introduction to FEM and many case studies of its use in engineering practice. It supports engineers and students to solve primarily linear problems in mechanical engineering, with a main focus on static and dynamic structural problems. Readers of this text are encouraged to discover the proper relationship between theory and practice, within the finite element method: Practice without theory is blind, but theory without practice is sterile. Beginning with elasticity basic concepts and the classical theories of stressed materials, the work goes on to apply the relationship between forces, displacements, stresses and strains on the process of modeling, simulating and designing engineered technical systems. Chapters discuss the finite element equations for static, eigenvalue analysis, as well as transient analyses. Students and practitioners using commercial FEM software will find this book very helpful. It us...

  5. Modelling drawbeads with finite elements and verification

    NARCIS (Netherlands)

    Carleer, B.D.; Carleer, B.D.; Vreede, P.T.; Vreede, P.T.; Louwes, M.F.M.; Louwes, M.F.M.; Huetink, Han

    1994-01-01

    Drawbeads are commonly used in deep drawing processes to control the flow of the blank during the forming operation. In finite element simulations of deep drawing the drawbead geometries are seldom included because of the small radii; because of these small radii a very large number of elements is

  6. Essentials of the finite element method for mechanical and structural engineers

    CERN Document Server

    Pavlou, Dimitrios G

    2015-01-01

    Fundamental coverage, analytic mathematics, and up-to-date software applications are hard to find in a single text on the finite element method (FEM). Dimitrios Pavlou's Essentials of the Finite Element Method: For Structural and Mechanical Engineers makes the search easier by providing a comprehensive but concise text for those new to FEM, or just in need of a refresher on the essentials. Essentials of the Finite Element Method explains the basics of FEM, then relates these basics to a number of practical engineering applications. Specific topics covered include linear spring elements, bar elements, trusses, beams and frames, heat transfer, and structural dynamics. Throughout the text, readers are shown step-by-step detailed analyses for finite element equations development. The text also demonstrates how FEM is programmed, with examples in MATLAB, CALFEM, and ANSYS allowing readers to learn how to develop their own computer code. Suitable for everyone from first-time BSc/MSc students to practicing mechanic...

  7. GIFFT: A Fast Solver for Modeling Sources in a Metamaterial Environment of Finite Size

    International Nuclear Information System (INIS)

    Capolino, F; Basilio, L; Fasenfest, B J; Wilton, D R

    2006-01-01

    Due to the recent explosion of interest in studying the electromagnetic behavior of large (truncated) periodic structures such as phased arrays, frequency-selective surfaces, and metamaterials, there has been a renewed interest in efficiently modeling such structures. Since straightforward numerical analyses of large, finite structures (i.e., explicitly meshing and computing interactions between all mesh elements of the entire structure) involve significant memory storage and computation times, much effort is currently being expended on developing techniques that minimize the high demand on computer resources. One such technique that belongs to the class of fast solvers for large periodic structures is the GIFFT algorithm (Green's function interpolation and FFT), which is first discussed in [1]. This method is a modification of the adaptive integral method (AIM) [2], a technique based on the projection of subdomain basis functions onto a rectangular grid. Like the methods presented in [3]-[4], the GIFFT algorithm is an extension of the AIM method in that it uses basis-function projections onto a rectangular grid through Lagrange interpolating polynomials. The use of a rectangular grid results in a matrix-vector product that is convolutional in form and can thus be evaluated using FFTs. Although our method differs from [3]-[6] in various respects, the primary differences between the AIM approach [2] and the GIFFT method [1] is the latter's use of interpolation to represent the Green's function (GF) and its specialization to periodic structures by taking into account the reusability properties of matrices that arise from interactions between identical cell elements. The present work extends the GIFFT algorithm to allow for a complete numerical analysis of a periodic structure excited by dipole source, as shown in Fig 1. Although GIFFT [1] was originally developed to handle strictly periodic structures, the technique has now been extended to efficiently handle a small

  8. A finite element solution method for quadrics parallel computer

    International Nuclear Information System (INIS)

    Zucchini, A.

    1996-08-01

    A distributed preconditioned conjugate gradient method for finite element analysis has been developed and implemented on a parallel SIMD Quadrics computer. The main characteristic of the method is that it does not require any actual assembling of all element equations in a global system. The physical domain of the problem is partitioned in cells of n p finite elements and each cell element is assigned to a different node of an n p -processors machine. Element stiffness matrices are stored in the data memory of the assigned processing node and the solution process is completely executed in parallel at element level. Inter-element and therefore inter-processor communications are required once per iteration to perform local sums of vector quantities between neighbouring elements. A prototype implementation has been tested on an 8-nodes Quadrics machine in a simple 2D benchmark problem

  9. Evaluation of Concrete Cylinder Tests Using Finite Elements

    DEFF Research Database (Denmark)

    Saabye Ottosen, Niels

    1984-01-01

    Nonlinear axisymmetric finite element analyses are performed on the uniaxial compressive test of concrete cylinders. The models include thick steel loading plates, and cylinders with height‐to‐diameter ratios (h/d) ranging from 1‐3 are treated. A simple constitutive model of the concrete is emplo......Nonlinear axisymmetric finite element analyses are performed on the uniaxial compressive test of concrete cylinders. The models include thick steel loading plates, and cylinders with height‐to‐diameter ratios (h/d) ranging from 1‐3 are treated. A simple constitutive model of the concrete...... uniaxial strength the use of geometrically matched loading plates seems to be advantageous. Finally, it is observed that for variations of the element size within limits otherwise required to obtain a realistic analysis, the results are insensitive to the element size....

  10. Application of three dimensional finite element modeling for the simulation of machining processes

    International Nuclear Information System (INIS)

    Fischer, C.E.; Wu, W.T.; Chigurupati, P.; Jinn, J.T.

    2004-01-01

    For many years, metal cutting simulations have been performed using two dimensional approximations of the actual process. Factors such as chip morphology, cutting force, temperature, and tool wear can all be predicted on the computer. However, two dimensional simulation is limited to processes which are orthogonal, or which can be closely approximated as orthogonal.Advances in finite element technology, coupled with continuing improvement in the availability of low cost, high performance computer hardware, have made the three dimensional simulation of a large variety of metal cutting processes practical. Specific improvements include efficient FEM solvers, and robust adaptive remeshing. As researchers continue to gain an improved understanding of wear, material representation, tool coatings, fracture, and other such phenomena, the machining simulation system also must adapt to incorporate these evolving models.To demonstrate the capabilities of the 3D simulation system, a variety of drilling, milling, and turning processes have been simulated and will be presented in this paper. Issues related to computation time and simulation accuracy will also be addressed

  11. Finite element analysis of structures through unified formulation

    CERN Document Server

    Carrera, Erasmo; Petrolo, Marco; Zappino, Enrico

    2014-01-01

    The finite element method (FEM) is a computational tool widely used to design and analyse  complex structures. Currently, there are a number of different approaches to analysis using the FEM that vary according to the type of structure being analysed: beams and plates may use 1D or 2D approaches, shells and solids 2D or 3D approaches, and methods that work for one structure are typically not optimized to work for another. Finite Element Analysis of Structures Through Unified Formulation deals with the FEM used for the analysis of the mechanics of structures in the case of linear elasticity. The novelty of this book is that the finite elements (FEs) are formulated on the basis of a class of theories of structures known as the Carrera Unified Formulation (CUF). It formulates 1D, 2D and 3D FEs on the basis of the same ''fundamental nucleus'' that comes from geometrical relations and Hooke''s law, and presents both 1D and 2D refined FEs that only have displacement variables as in 3D elements. It also covers 1D...

  12. Exponentially-convergent Monte Carlo via finite-element trial spaces

    International Nuclear Information System (INIS)

    Morel, Jim E.; Tooley, Jared P.; Blamer, Brandon J.

    2011-01-01

    Exponentially-Convergent Monte Carlo (ECMC) methods, also known as adaptive Monte Carlo and residual Monte Carlo methods, were the subject of intense research over a decade ago, but they never became practical for solving the realistic problems. We believe that the failure of previous efforts may be related to the choice of trial spaces that were global and thus highly oscillatory. As an alternative, we consider finite-element trial spaces, which have the ability to treat fully realistic problems. As a first step towards more general methods, we apply piecewise-linear trial spaces to the spatially-continuous two-stream transport equation. Using this approach, we achieve exponential convergence and computationally demonstrate several fundamental properties of finite-element based ECMC methods. Finally, our results indicate that the finite-element approach clearly deserves further investigation. (author)

  13. Finite element simulation of ironing process under warm conditions

    Directory of Open Access Journals (Sweden)

    Swadesh Kumar Singh

    2014-01-01

    Full Text Available Metal forming is one of the most important steps in manufacturing of a large variety of products. Ironing in deep drawing is done by adjusting the clearance between the punch and the die and allow the material flow over the punch. In the present investigation effect of extent of ironing behavior on the characteristics of the product like thickness distribution with respect to temperature was studied. With the help of finite element simulation using explicit finite element code LS-DYNA the stress in the drawn cup were predicted in the drawn cup. To increase the accuracy in the simulation process, numbers of integration points were increased in the thickness direction and it was found that there is very close prediction of finite element results to that of experimental ones.

  14. Analysis of Tube Drawing Process – A Finite Element Approach ...

    African Journals Online (AJOL)

    In this paper the effect of die semi angle on drawing load in cold tube drawing has been investigated numerically using the finite element method. The equation governing the stress distribution was derived and solved using Galerkin finite element method. An isoparametric formulation for the governing equation was utilized ...

  15. Hybrid mesh finite volume CFD code for studying heat transfer in a forward-facing step

    Energy Technology Data Exchange (ETDEWEB)

    Jayakumar, J S; Kumar, Inder [Bhabha Atomic Research Center, Mumbai (India); Eswaran, V, E-mail: jsjayan@gmail.com, E-mail: inderk@barc.gov.in, E-mail: eswar@iitk.ac.in [Indian Institute of Technology, Kanpur (India)

    2010-12-15

    Computational fluid dynamics (CFD) methods employ two types of grid: structured and unstructured. Developing the solver and data structures for a finite-volume solver is easier than for unstructured grids. But real-life problems are too complicated to be fitted flexibly by structured grids. Therefore, unstructured grids are widely used for solving real-life problems. However, using only one type of unstructured element consumes a lot of computational time because the number of elements cannot be controlled. Hence, a hybrid grid that contains mixed elements, such as the use of hexahedral elements along with tetrahedral and pyramidal elements, gives the user control over the number of elements in the domain, and thus only the domain that requires a finer grid is meshed finer and not the entire domain. This work aims to develop such a finite-volume hybrid grid solver capable of handling turbulence flows and conjugate heat transfer. It has been extended to solving flow involving separation and subsequent reattachment occurring due to sudden expansion or contraction. A significant effect of mixing high- and low-enthalpy fluid occurs in the reattached regions of these devices. This makes the study of the backward-facing and forward-facing step with heat transfer an important field of research. The problem of the forward-facing step with conjugate heat transfer was taken up and solved for turbulence flow using a two-equation model of k-{omega}. The variation in the flow profile and heat transfer behavior has been studied with the variation in Re and solid to fluid thermal conductivity ratios. The results for the variation in local Nusselt number, interface temperature and skin friction factor are presented.

  16. Hybrid mesh finite volume CFD code for studying heat transfer in a forward-facing step

    Science.gov (United States)

    Jayakumar, J. S.; Kumar, Inder; Eswaran, V.

    2010-12-01

    Computational fluid dynamics (CFD) methods employ two types of grid: structured and unstructured. Developing the solver and data structures for a finite-volume solver is easier than for unstructured grids. But real-life problems are too complicated to be fitted flexibly by structured grids. Therefore, unstructured grids are widely used for solving real-life problems. However, using only one type of unstructured element consumes a lot of computational time because the number of elements cannot be controlled. Hence, a hybrid grid that contains mixed elements, such as the use of hexahedral elements along with tetrahedral and pyramidal elements, gives the user control over the number of elements in the domain, and thus only the domain that requires a finer grid is meshed finer and not the entire domain. This work aims to develop such a finite-volume hybrid grid solver capable of handling turbulence flows and conjugate heat transfer. It has been extended to solving flow involving separation and subsequent reattachment occurring due to sudden expansion or contraction. A significant effect of mixing high- and low-enthalpy fluid occurs in the reattached regions of these devices. This makes the study of the backward-facing and forward-facing step with heat transfer an important field of research. The problem of the forward-facing step with conjugate heat transfer was taken up and solved for turbulence flow using a two-equation model of k-ω. The variation in the flow profile and heat transfer behavior has been studied with the variation in Re and solid to fluid thermal conductivity ratios. The results for the variation in local Nusselt number, interface temperature and skin friction factor are presented.

  17. Hybrid mesh finite volume CFD code for studying heat transfer in a forward-facing step

    International Nuclear Information System (INIS)

    Jayakumar, J S; Kumar, Inder; Eswaran, V

    2010-01-01

    Computational fluid dynamics (CFD) methods employ two types of grid: structured and unstructured. Developing the solver and data structures for a finite-volume solver is easier than for unstructured grids. But real-life problems are too complicated to be fitted flexibly by structured grids. Therefore, unstructured grids are widely used for solving real-life problems. However, using only one type of unstructured element consumes a lot of computational time because the number of elements cannot be controlled. Hence, a hybrid grid that contains mixed elements, such as the use of hexahedral elements along with tetrahedral and pyramidal elements, gives the user control over the number of elements in the domain, and thus only the domain that requires a finer grid is meshed finer and not the entire domain. This work aims to develop such a finite-volume hybrid grid solver capable of handling turbulence flows and conjugate heat transfer. It has been extended to solving flow involving separation and subsequent reattachment occurring due to sudden expansion or contraction. A significant effect of mixing high- and low-enthalpy fluid occurs in the reattached regions of these devices. This makes the study of the backward-facing and forward-facing step with heat transfer an important field of research. The problem of the forward-facing step with conjugate heat transfer was taken up and solved for turbulence flow using a two-equation model of k-ω. The variation in the flow profile and heat transfer behavior has been studied with the variation in Re and solid to fluid thermal conductivity ratios. The results for the variation in local Nusselt number, interface temperature and skin friction factor are presented.

  18. A finite element for plates and shells

    International Nuclear Information System (INIS)

    Muller, A.; Feijoo, R.A.; Bevilacqua, L.

    1981-08-01

    A simple triangular finite element for plates and shells, is presented. Since the rotation fields are assumed independent of the displacement fields, the element allows one to solve thick shells problems. In the limit for thin shell, the Kirchoff-Love hypothesis is automatically satisfied, thus enlarging its range of application. (Author) [pt

  19. COMPUTER EXPERIMENTS WITH FINITE ELEMENTS OF HIGHER ORDER

    Directory of Open Access Journals (Sweden)

    Khomchenko A.

    2017-12-01

    Full Text Available The paper deals with the problem of constructing the basic functions of a quadrilateral finite element of the fifth order by the means of the computer algebra system Maple. The Lagrangian approximation of such a finite element contains 36 nodes: 20 nodes perimeter and 16 internal nodes. Alternative models with reduced number of internal nodes are considered. Graphs of basic functions and cognitive portraits of lines of zero level are presented. The work is aimed at studying the possibilities of using modern information technologies in the teaching of individual mathematical disciplines.

  20. Fourier analysis of finite element preconditioned collocation schemes

    Science.gov (United States)

    Deville, Michel O.; Mund, Ernest H.

    1990-01-01

    The spectrum of the iteration operator of some finite element preconditioned Fourier collocation schemes is investigated. The first part of the paper analyses one-dimensional elliptic and hyperbolic model problems and the advection-diffusion equation. Analytical expressions of the eigenvalues are obtained with use of symbolic computation. The second part of the paper considers the set of one-dimensional differential equations resulting from Fourier analysis (in the tranverse direction) of the 2-D Stokes problem. All results agree with previous conclusions on the numerical efficiency of finite element preconditioning schemes.

  1. Stochastic Finite Elements in Reliability-Based Structural Optimization

    DEFF Research Database (Denmark)

    Sørensen, John Dalsgaard; Engelund, S.

    Application of stochastic finite elements in structural optimization is considered. It is shown how stochastic fields modelling e.g. the modulus of elasticity can be discretized in stochastic variables and how a sensitivity analysis of the reliability of a structural system with respect to optimi......Application of stochastic finite elements in structural optimization is considered. It is shown how stochastic fields modelling e.g. the modulus of elasticity can be discretized in stochastic variables and how a sensitivity analysis of the reliability of a structural system with respect...

  2. Modelling bucket excavation by finite element

    Science.gov (United States)

    Pecingina, O. M.

    2015-11-01

    Changes in geological components of the layers from lignite pits have an impact on the sustainability of the cup path elements and under the action of excavation force appear efforts leading to deformation of the entire assembly. Application of finite element method in the optimization of components leads to economic growth, to increase the reliability and durability of the studied machine parts thus the machine. It is obvious usefulness of knowledge the state of mechanical tensions that the designed piece or the assembly not to break under the action of tensions that must cope during operation. In the course of excavation work on all bucket cutting force components, the first coming into contact with the material being excavated cutting edge. Therefore in the study with finite element analysis is retained only cutting edge. To study the field of stress and strain on the cutting edge will be created geometric patterns for each type of cup this will be subject to static analysis. The geometric design retains the cutting edge shape and on this on the tooth cassette location will apply an areal force on the abutment tooth. The cutting edge real pattern is subjected to finite element study for the worst case of rock cutting by symmetrical and asymmetrical cups whose profile is different. The purpose of this paper is to determine the displacement and tensions field for both profiles considering the maximum force applied on the cutting edge and the depth of the cutting is equal with the width of the cutting edge of the tooth. It will consider the worst case when on the structure will act both the tangential force and radial force on the bucket profile. For determination of stress and strain field on the form design of cutting edge profile will apply maximum force assuming uniform distribution and on the edge surface force will apply a radial force. After geometric patterns discretization on the cutting knives and determining stress field, can be seen that at the

  3. Introduction to the Explicit Finite Element Method for Nonlinear Transient Dynamics

    CERN Document Server

    Wu, Shen R

    2012-01-01

    A systematic introduction to the theories and formulations of the explicit finite element method As numerical technology continues to grow and evolve with industrial applications, understanding the explicit finite element method has become increasingly important, particularly in the areas of crashworthiness, metal forming, and impact engineering. Introduction to the Explicit FiniteElement Method for Nonlinear Transient Dynamics is the first book to address specifically what is now accepted as the most successful numerical tool for nonlinear transient dynamics. The book aids readers in master

  4. A study on the improvement of shape optimization associated with the modification of a finite element

    International Nuclear Information System (INIS)

    Sung, Jin Il; Yoo, Jeong Hoon

    2002-01-01

    In this paper, we investigate the effect and the importance of the accuracy of finite element analysis in the shape optimization based on the finite element method and improve the existing finite element which has inaccuracy in some cases. And then, the shape optimization is performed by using the improved finite element. One of the main stream to improve finite element is the prevention of locking phenomenon. In case of bending dominant problems, finite element solutions cannot be reliable because of shear locking phenomenon. In the process of shape optimization, the mesh distortion is large due to the change of the structure outline. So, we have to raise the accuracy of finite element analysis for the large mesh distortion. We cannot guarantee the accurate result unless the finite element itself is accurate or the finite elements are remeshed. So, we approach to more accurate shape optimization to diminish these inaccuracies by improving the existing finite element. The shape optimization using the modified finite element is applied to a two and three dimensional simple beam. Results show that the modified finite element has improved the optimization results

  5. The DANTE Boltzmann transport solver: An unstructured mesh, 3-D, spherical harmonics algorithm compatible with parallel computer architectures

    International Nuclear Information System (INIS)

    McGhee, J.M.; Roberts, R.M.; Morel, J.E.

    1997-01-01

    A spherical harmonics research code (DANTE) has been developed which is compatible with parallel computer architectures. DANTE provides 3-D, multi-material, deterministic, transport capabilities using an arbitrary finite element mesh. The linearized Boltzmann transport equation is solved in a second order self-adjoint form utilizing a Galerkin finite element spatial differencing scheme. The core solver utilizes a preconditioned conjugate gradient algorithm. Other distinguishing features of the code include options for discrete-ordinates and simplified spherical harmonics angular differencing, an exact Marshak boundary treatment for arbitrarily oriented boundary faces, in-line matrix construction techniques to minimize memory consumption, and an effective diffusion based preconditioner for scattering dominated problems. Algorithm efficiency is demonstrated for a massively parallel SIMD architecture (CM-5), and compatibility with MPP multiprocessor platforms or workstation clusters is anticipated

  6. Finite element analysis of car hood for impact test by using ...

    African Journals Online (AJOL)

    Finite element analysis of car hood for impact test by using solidworks software ... high safety and at the same time can be built according to market demands. ... Keywords: finite element analysis; impact test; Solidworks; automation, car hood.

  7. Coupling of a 3-D vortex particle-mesh method with a finite volume near-wall solver

    Science.gov (United States)

    Marichal, Y.; Lonfils, T.; Duponcheel, M.; Chatelain, P.; Winckelmans, G.

    2011-11-01

    This coupling aims at improving the computational efficiency of high Reynolds number bluff body flow simulations by using two complementary methods and exploiting their respective advantages in distinct parts of the domain. Vortex particle methods are particularly well suited for free vortical flows such as wakes or jets (the computational domain -with non zero vorticity- is then compact and dispersion errors are negligible). Finite volume methods, however, can handle boundary layers much more easily due to anisotropic mesh refinement. In the present approach, the vortex method is used in the whole domain (overlapping domain technique) but its solution is highly underresolved in the vicinity of the wall. It thus has to be corrected by the near-wall finite volume solution at each time step. Conversely, the vortex method provides the outer boundary conditions for the near-wall solver. A parallel multi-resolution vortex particle-mesh approach is used here along with an Immersed Boundary method in order to take the walls into account. The near-wall flow is solved by OpenFOAM® using the PISO algorithm. We validate the methodology on the flow past a sphere at a moderate Reynolds number. F.R.S. - FNRS Research Fellow.

  8. Coupling of smooth particle hydrodynamics with the finite element method

    International Nuclear Information System (INIS)

    Attaway, S.W.; Heinstein, M.W.; Swegle, J.W.

    1994-01-01

    A gridless technique called smooth particle hydrodynamics (SPH) has been coupled with the transient dynamics finite element code ppercase[pronto]. In this paper, a new weighted residual derivation for the SPH method will be presented, and the methods used to embed SPH within ppercase[pronto] will be outlined. Example SPH ppercase[pronto] calculations will also be presented. One major difficulty associated with the Lagrangian finite element method is modeling materials with no shear strength; for example, gases, fluids and explosive biproducts. Typically, these materials can be modeled for only a short time with a Lagrangian finite element code. Large distortions cause tangling of the mesh, which will eventually lead to numerical difficulties, such as negative element area or ''bow tie'' elements. Remeshing will allow the problem to continue for a short while, but the large distortions can prevent a complete analysis. SPH is a gridless Lagrangian technique. Requiring no mesh, SPH has the potential to model material fracture, large shear flows and penetration. SPH computes the strain rate and the stress divergence based on the nearest neighbors of a particle, which are determined using an efficient particle-sorting technique. Embedding the SPH method within ppercase[pronto] allows part of the problem to be modeled with quadrilateral finite elements, while other parts are modeled with the gridless SPH method. SPH elements are coupled to the quadrilateral elements through a contact-like algorithm. ((orig.))

  9. Finite element formulation for dynamics of planar flexible multi-beam system

    International Nuclear Information System (INIS)

    Liu Zhuyong; Hong Jiazhen; Liu Jinyang

    2009-01-01

    In some previous geometric nonlinear finite element formulations, due to the use of axial displacement, the contribution of all the elements lying between the reference node of zero axial displacement and the element to the foreshortening effect should be taken into account. In this paper, a finite element formulation is proposed based on geometric nonlinear elastic theory and finite element technique. The coupling deformation terms of an arbitrary point only relate to the nodal coordinates of the element at which the point is located. Based on Hamilton principle, dynamic equations of elastic beams undergoing large overall motions are derived. To investigate the effect of coupling deformation terms on system dynamic characters and reduce the dynamic equations, a complete dynamic model and three reduced models of hub-beam are prospected. When the Cartesian deformation coordinates are adopted, the results indicate that the terms related to the coupling deformation in the inertia forces of dynamic equations have small effect on system dynamic behavior and may be neglected, whereas the terms related to coupling deformation in the elastic forces are important for system dynamic behavior and should be considered in dynamic equation. Numerical examples of the rotating beam and flexible beam system are carried out to demonstrate the accuracy and validity of this dynamic model. Furthermore, it is shown that a small number of finite elements are needed to obtain a stable solution using the present coupling finite element formulation

  10. Finite element analysis of the neutron transport equation in spherical geometry

    International Nuclear Information System (INIS)

    Kim, Yong Ill; Kim, Jong Kyung; Suk, Soo Dong

    1992-01-01

    The Galerkin formulation of the finite element method is applied to the integral law of the first-order form of the one-group neutron transport equation in one-dimensional spherical geometry. Piecewise linear or quadratic Lagrange polynomials are utilized in the integral law for the angular flux to establish a set of linear algebraic equations. Numerical analyses are performed for the scalar flux distribution in a heterogeneous sphere as well as for the criticality problem in a uniform sphere. For the criticality problems in the uniform sphere, the results of the finite element method, with the use of continuous finite elements in space and angle, are compared with the exact solutions. In the heterogeneous problem, the scalar flux distribution obtained by using discontinuous angular and spatical finite elements is in good agreement with that from the ANISN code calculation. (Author)

  11. Maxwell's equations in axisymmetrical geometry: coupling H(curl) finite element in volume and H(div) finite element in surface. The numerical code FuMel

    International Nuclear Information System (INIS)

    Cambon, S.; Lacoste, P.

    2011-01-01

    We propose a finite element method to solve the axisymmetric scattering problem posed on a regular bounded domain. Here we shall show how to reduce the initial 3D problem into a truncated sum of 2D independent problems posed into a meridian plane of the object. Each of these problem results in the coupling of a partial differential equation into the interior domain and an integral equation on the surface simulating the free space. Then variational volume and boundary integral formulations of Maxwell's equation on regular surfaces are derived. We introduce some general finite element adapted to cylindrical coordinates and constructed from nodal and mixed finite element both for the interior (volume) and for the integral equation (surface). (authors)

  12. Isogeometric finite element analysis of poroelasticity

    NARCIS (Netherlands)

    Irzal, F.; Remmers, J.J.C.; Verhoosel, C.V.; Borst, de R.

    2013-01-01

    We present an alternative numerical approach for predicting the behaviour of a deformable fluid-saturated porous medium. The conventional finite element technology is replaced by isogeometric analysis that uses non-uniform rational B-splines. The ability of these functions to provide higher-order

  13. Fast finite elements for surgery simulation

    DEFF Research Database (Denmark)

    Bro-Nielsen, Morten

    1997-01-01

    This paper discusses volumetric deformable models for modeling human body parts and organs in surgery simulation systems. These models are built using finite element models for linear elastic materials. To achieve real-time response condensation has been applied to the system stiffness matrix...

  14. Simplicial Finite Elements in Higher Dimensions

    Czech Academy of Sciences Publication Activity Database

    Brandts, J.; Korotov, S.; Křížek, Michal

    2007-01-01

    Roč. 52, č. 3 (2007), s. 251-265 ISSN 0862-7940 R&D Projects: GA ČR GA201/04/1503 Institutional research plan: CEZ:AV0Z10190503 Keywords : n-simplex * finite element method * superconvergence Subject RIV: BA - General Mathematics

  15. Finite element analysis of human joints

    Energy Technology Data Exchange (ETDEWEB)

    Bossart, P.L.; Hollerbach, K.

    1996-09-01

    Our work focuses on the development of finite element models (FEMs) that describe the biomechanics of human joints. Finite element modeling is becoming a standard tool in industrial applications. In highly complex problems such as those found in biomechanics research, however, the full potential of FEMs is just beginning to be explored, due to the absence of precise, high resolution medical data and the difficulties encountered in converting these enormous datasets into a form that is usable in FEMs. With increasing computing speed and memory available, it is now feasible to address these challenges. We address the first by acquiring data with a high resolution C-ray CT scanner and the latter by developing semi-automated method for generating the volumetric meshes used in the FEM. Issues related to tomographic reconstruction, volume segmentation, the use of extracted surfaces to generate volumetric hexahedral meshes, and applications of the FEM are described.

  16. Finite element analysis of human joints

    International Nuclear Information System (INIS)

    Bossart, P.L.; Hollerbach, K.

    1996-09-01

    Our work focuses on the development of finite element models (FEMs) that describe the biomechanics of human joints. Finite element modeling is becoming a standard tool in industrial applications. In highly complex problems such as those found in biomechanics research, however, the full potential of FEMs is just beginning to be explored, due to the absence of precise, high resolution medical data and the difficulties encountered in converting these enormous datasets into a form that is usable in FEMs. With increasing computing speed and memory available, it is now feasible to address these challenges. We address the first by acquiring data with a high resolution C-ray CT scanner and the latter by developing semi-automated method for generating the volumetric meshes used in the FEM. Issues related to tomographic reconstruction, volume segmentation, the use of extracted surfaces to generate volumetric hexahedral meshes, and applications of the FEM are described

  17. Finite element method for computational fluid dynamics with any type of elements; Finite Element Methode zur numerischen Stroemungsberechnung mit beliebigen Elementen

    Energy Technology Data Exchange (ETDEWEB)

    Steibler, P.

    2000-07-01

    The unsteady, turbulent flow is to be calculated in a complex geometry. For this purpose a stabilized finite element formulation in which the same functions for velocity and pressure are used is developed. Thus the process remains independent of the type of elements. This simplifies the application. Above all, it is easier to deal with the boundary conditions. The independency from the elements is also achieved by the extended uzawa-algorithm which uses quadratic functions for velocity and an element-constant pressure. This method is also programmed. In order to produce the unstructured grids, an algorithm is implemented which produces meshes consisting of triangular and tetrahedral elements with flow-dependent adaptation. With standard geometries both calculation methods are compared with results. Finally the flow in a draft tube of a Kaplan turbine is calculated and compared with results from model tests. (orig.) [German] Die instationaere, turbulente Stroemung in einer komplexen Geometrie soll berechnet werden. Dazu wird eine Stabilisierte Finite Element Formulierung entwickelt, bei der die gleichen Ansatzfunktionen fuer Geschwindigkeiten und Druck verwendet werden. Das Verfahren wird damit unabhaengig von der Form der Elemente. Dies vereinfacht die Anwendung. Vor allem wird der Umgang mit den Randbedingungen erleichert. Die Elementunabhaengigkeit erreicht man auch mit dem erweiterten Uzawa-Algorithmus, welcher quadratische Ansatzfunktionen fuer die Geschwindigkeiten und elementweisen konstanten Druck verwendet. Dieses Verfahren wird ebenso implementiert. Zur Erstellung der unstrukturierten Gitter wird ein Algorithmus erzeugt, der Netze aus Dreiecks- und Tetraederelementen erstellt, welche stroemungsabhaengige Groessen besitzen koennen. Anhand einiger Standardgeometrien werden die beiden Berechnungsmethoden mit Ergebnissen aus der Literatur verglichen. Als praxisrelevantes Beispiel wird abschliessend die Stroemung in einem Saugrohr einer Kaplanturbine berechnet

  18. Finite element simulation of piezoelectric transformers.

    Science.gov (United States)

    Tsuchiya, T; Kagawa, Y; Wakatsuki, N; Okamura, H

    2001-07-01

    Piezoelectric transformers are nothing but ultrasonic resonators with two pairs of electrodes provided on the surface of a piezoelectric substrate in which electrical energy is carried in the mechanical form. The input and output electrodes are arranged to provide the impedance transformation, which results in the voltage transformation. As they are operated at a resonance, the electrical equivalent circuit approach has traditionally been developed in a rather empirical way and has been used for analysis and design. The present paper deals with the analysis of the piezoelectric transformers based on the three-dimensional finite element modelling. The PIEZO3D code that we have developed is modified to include the external loading conditions. The finite element approach is now available for a wide variety of the electrical boundary conditions. The equivalent circuit of lumped parameters can also be derived from the finite element method (FEM) solution if required. The simulation of the present transformers is made for the low intensity operation and compared with the experimental results. Demonstration is made for basic Rosen-type transformers in which the longitudinal mode of a plate plays an important role; in which the equivalent circuit of lumped constants has been used. However, there are many modes of vibration associated with the plate, the effect of which cannot always be ignored. In the experiment, the double resonances are sometimes observed in the vicinity of the operating frequency. The simulation demonstrates that this is due to the coupling of the longitudinal mode with the flexural mode. Thus, the simulation provides an invaluable guideline to the transformer design.

  19. A Note on Symplectic, Multisymplectic Scheme in Finite Element Method

    Institute of Scientific and Technical Information of China (English)

    GUO Han-Ying; JI Xiao-Mei; LI Yu-Qi; WU Ke

    2001-01-01

    We find that with uniform mesh, the numerical schemes derived from finite element method can keep a preserved symplectic structure in one-dimensional case and a preserved multisymplectic structure in two-dimensional case respectively. These results are in fact the intrinsic reason why the numerical experiments show that such finite element algorithms are accurate in practice.``

  20. A Novel Polygonal Finite Element Method: Virtual Node Method

    Science.gov (United States)

    Tang, X. H.; Zheng, C.; Zhang, J. H.

    2010-05-01

    Polygonal finite element method (PFEM), which can construct shape functions on polygonal elements, provides greater flexibility in mesh generation. However, the non-polynomial form of traditional PFEM, such as Wachspress method and Mean Value method, leads to inexact numerical integration. Since the integration technique for non-polynomial functions is immature. To overcome this shortcoming, a great number of integration points have to be used to obtain sufficiently exact results, which increases computational cost. In this paper, a novel polygonal finite element method is proposed and called as virtual node method (VNM). The features of present method can be list as: (1) It is a PFEM with polynomial form. Thereby, Hammer integral and Gauss integral can be naturally used to obtain exact numerical integration; (2) Shape functions of VNM satisfy all the requirements of finite element method. To test the performance of VNM, intensive numerical tests are carried out. It found that, in standard patch test, VNM can achieve significantly better results than Wachspress method and Mean Value method. Moreover, it is observed that VNM can achieve better results than triangular 3-node elements in the accuracy test.

  1. Comparison of 3-D finite elements for incompressible fluid flow

    International Nuclear Information System (INIS)

    Robichaud, M.; Tanguy, P.A.

    1985-01-01

    In recent years, the finite element method applied to the solution of incompressible fluid flow has been in constant evolution. In the present state-of-the-art, 2-D problems are solved routinely and reliable results are obtained at a reasonable cost. In 3-D the finite element method is still undergoing active research and many methods have been proposed to solve the Navier-Stokes equations at 'low cost'. These methods have in common the choice of the element which has a trilinear velocity and a discontinuous constant pressure (Q1-PO). The prohibitive cost of 3-D finite element method in fluid flow is the reason for this choice: the Q1-PO is the simplest and the cheapest 3-D element. However, as mentioned in (5) and (6), it generates 'spurious' pressure modes phenomenon called checkerboarding. On regular mesh these spurious modes can be filtered but on distorted mesh the pressure solution is meaningless. (author)

  2. Finite element analysis of an inflatable torus considering air mass structural element

    Science.gov (United States)

    Gajbhiye, S. C.; Upadhyay, S. H.; Harsha, S. P.

    2014-01-01

    Inflatable structures, also known as gossamer structures, are at high boom in the current space technology due to their low mass and compact size comparing to the traditional spacecraft designing. Internal pressure becomes the major source of strength and rigidity, essentially stiffen the structure. However, inflatable space based membrane structure are at high risk to the vibration disturbance due to their low structural stiffness and material damping. Hence, the vibration modes of the structure should be known to a high degree of accuracy in order to provide better control authority. In the past, most of the studies conducted on the vibration analysis of gossamer structures used inaccurate or approximate theories in modeling the internal pressure. The toroidal shaped structure is one of the important key element in space application, helps to support the reflector in space application. This paper discusses the finite-element analysis of an inflated torus. The eigen-frequencies are obtained via three-dimensional small-strain elasticity theory, based on extremum energy principle. The two finite-element model (model-1 and model-2) have cases have been generated using a commercial finite-element package. The structure model-1 with shell element and model-2 with the combination of the mass of enclosed fluid (air) added to the shell elements have been taken for the study. The model-1 is computed with present analytical approach to understand the convergence rate and the accuracy. The convergence study is made available for the symmetric modes and anti-symmetric modes about the centroidal-axis plane, meeting the eigen-frequencies of an inflatable torus with the circular cross section. The structural model-2 is introduced with air mass element and analyzed its eigen-frequency with different aspect ratio and mode shape response using in-plane and out-plane loading condition are studied.

  3. Error-controlled adaptive finite elements in solid mechanics

    National Research Council Canada - National Science Library

    Stein, Erwin; Ramm, E

    2003-01-01

    ... . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . Error-controlled Adaptive Finite-element-methods . . . . . . . . . . . . Missing Features and Properties of Today's General Purpose FE Programs for Structural...

  4. Stress analysis of heated concrete using finite elements

    International Nuclear Information System (INIS)

    Majumdar, P.; Gupta, A.; Marchertas, A.

    1994-01-01

    Described is a finite element analysis of concrete, which is subjected to rapid heating. Using thermal mass transport calculation, the moisture content, temperature and pore pressure distribution over space and time is obtained first. From these effects, stress at various points of the concrete are computed using the finite element method. Contribution to the stress formulation comes from three components, namely the thermal expansion, pore pressure, and the shrinkage of concrete due to moisture loss (from dehydration). The material properties of concrete are assumed to be homogeneous, elastic, and cracking is not taken into consideration. (orig.)

  5. Finite element simulation of internal flows with heat transfer using a ...

    Indian Academy of Sciences (India)

    Unknown

    Velocity correction method; finite element simulation; turbulent .... CFD, developments in turbulence modeling have been only evolutionary and ...... variables are made dimensionless using appropriate combinations of Uav, H, ...... Srinivas M 1994 Finite element analysis of internal flows with heat transfer Ph D thesis, Indian.

  6. Finite Macro-Element Mesh Deformation in a Structured Multi-Block Navier-Stokes Code

    Science.gov (United States)

    Bartels, Robert E.

    2005-01-01

    A mesh deformation scheme is developed for a structured multi-block Navier-Stokes code consisting of two steps. The first step is a finite element solution of either user defined or automatically generated macro-elements. Macro-elements are hexagonal finite elements created from a subset of points from the full mesh. When assembled, the finite element system spans the complete flow domain. Macro-element moduli vary according to the distance to the nearest surface, resulting in extremely stiff elements near a moving surface and very pliable elements away from boundaries. Solution of the finite element system for the imposed boundary deflections generally produces smoothly varying nodal deflections. The manner in which distance to the nearest surface has been found to critically influence the quality of the element deformation. The second step is a transfinite interpolation which distributes the macro-element nodal deflections to the remaining fluid mesh points. The scheme is demonstrated for several two-dimensional applications.

  7. Integral finite element analysis of turntable bearing with flexible rings

    Science.gov (United States)

    Deng, Biao; Liu, Yunfei; Guo, Yuan; Tang, Shengjin; Su, Wenbin; Lei, Zhufeng; Wang, Pengcheng

    2018-03-01

    This paper suggests a method to calculate the internal load distribution and contact stress of the thrust angular contact ball turntable bearing by FEA. The influence of the stiffness of the bearing structure and the plastic deformation of contact area on the internal load distribution and contact stress of the bearing is considered. In this method, the load-deformation relationship of the rolling elements is determined by the finite element contact analysis of a single rolling element and the raceway. Based on this, the nonlinear contact between the rolling elements and the inner and outer ring raceways is same as a nonlinear compression spring and bearing integral finite element analysis model including support structure was established. The effects of structural deformation and plastic deformation on the built-in stress distribution of slewing bearing are investigated on basis of comparing the consequences of load distribution, inner and outer ring stress, contact stress and other finite element analysis results with the traditional bearing theory, which has guiding function for improving the design of slewing bearing.

  8. Finite Element Simulation of Fracture Toughness Test

    International Nuclear Information System (INIS)

    Chu, Seok Jae; Liu, Cong Hao

    2013-01-01

    Finite element simulations of tensile tests were performed to determine the equivalent stress - equivalent plastic strain curves, critical equivalent stresses, and critical equivalent plastic strains. Then, the curves were used as inputs to finite element simulations of fracture toughness tests to determine the plane strain fracture toughness. The critical COD was taken as the COD when the equivalent plastic strain at the crack tip reached a critical value, and it was used as a crack growth criterion. The relationship between the critical COD and the critical equivalent plastic strain or the reduction of area was found. The relationship between the plane strain fracture toughness and the product of the critical equivalent stress and the critical equivalent plastic strain was also found

  9. Verification of continuum drift kinetic equation solvers in NIMROD

    Energy Technology Data Exchange (ETDEWEB)

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

    2015-03-15

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

  10. Semianalytic Design Sensitivity Analysis of Nonlinear Structures With a Commercial Finite Element Package

    International Nuclear Information System (INIS)

    Lee, Tae Hee; Yoo, Jung Hun; Choi, Hyeong Cheol

    2002-01-01

    A finite element package is often used as a daily design tool for engineering designers in order to analyze and improve the design. The finite element analysis can provide the responses of a system for given design variables. Although finite element analysis can quite well provide the structural behaviors for given design variables, it cannot provide enough information to improve the design such as design sensitivity coefficients. Design sensitivity analysis is an essential step to predict the change in responses due to a change in design variables and to optimize a system with the aid of the gradient-based optimization techniques. To develop a numerical method of design sensitivity analysis, analytical derivatives that are based on analytical differentiation of the continuous or discrete finite element equations are effective but analytical derivatives are difficult because of the lack of internal information of the commercial finite element package such as shape functions. Therefore, design sensitivity analysis outside of the finite element package is necessary for practical application in an industrial setting. In this paper, the semi-analytic method for design sensitivity analysis is used for the development of the design sensitivity module outside of a commercial finite element package of ANSYS. The direct differentiation method is employed to compute the design derivatives of the response and the pseudo-load for design sensitivity analysis is effectively evaluated by using the design variation of the related internal nodal forces. Especially, we suggest an effective method for stress and nonlinear design sensitivity analyses that is independent of the commercial finite element package is also discussed. Numerical examples are illustrated to show the accuracy and efficiency of the developed method and to provide insights for implementation of the suggested method into other commercial finite element packages

  11. Numerical solution of multi group-Two dimensional- Adjoint equation with finite element method

    International Nuclear Information System (INIS)

    Poursalehi, N.; Khalafi, H.; Shahriari, M.; Minoochehr

    2008-01-01

    Adjoint equation is used for perturbation theory in nuclear reactor design. For numerical solution of adjoint equation, usually two methods are applied. These are Finite Element and Finite Difference procedures. Usually Finite Element Procedure is chosen for solving of adjoint equation, because it is more use able in variety of geometries. In this article, Galerkin Finite Element method is discussed. This method is applied for numerical solving multi group, multi region and two dimensional (X, Y) adjoint equation. Typical reactor geometry is partitioned with triangular meshes and boundary condition for adjoint flux is considered zero. Finally, for a case of defined parameters, Finite Element Code was applied and results were compared with Citation Code

  12. Implementation of advanced finite element technology in structural analysis computer codes

    International Nuclear Information System (INIS)

    Kohli, T.D.; Wiley, J.W.; Koss, P.W.

    1975-01-01

    Advances in finite element technology over the last several years have been rapid and have largely outstripped the ability of general purpose programs in the public domain to assimilate them. As a result, it has become the burden of the structural analyst to incorporate these advances himself. This paper discusses the implementation and extension of specific technological advances in Bechtel structural analysis programs. In general these advances belong in two categories: (1) the finite elements themselves and (2) equation solution algorithms. Improvements in the finite elements involve increased accuracy of the elements and extension of their applicability to various specialized modelling situations. Improvements in solution algorithms have been almost exclusively aimed at expanding problem solving capacity. (Auth.)

  13. Probabilistic finite elements for transient analysis in nonlinear continua

    Science.gov (United States)

    Liu, W. K.; Belytschko, T.; Mani, A.

    1985-01-01

    The probabilistic finite element method (PFEM), which is a combination of finite element methods and second-moment analysis, is formulated for linear and nonlinear continua with inhomogeneous random fields. Analogous to the discretization of the displacement field in finite element methods, the random field is also discretized. The formulation is simplified by transforming the correlated variables to a set of uncorrelated variables through an eigenvalue orthogonalization. Furthermore, it is shown that a reduced set of the uncorrelated variables is sufficient for the second-moment analysis. Based on the linear formulation of the PFEM, the method is then extended to transient analysis in nonlinear continua. The accuracy and efficiency of the method is demonstrated by application to a one-dimensional, elastic/plastic wave propagation problem. The moments calculated compare favorably with those obtained by Monte Carlo simulation. Also, the procedure is amenable to implementation in deterministic FEM based computer programs.

  14. Adaptive finite-element ballooning analysis of bipolar ionized fields

    International Nuclear Information System (INIS)

    Al-Hamouz, Z.M.

    1995-01-01

    This paper presents an adaptive finite-element iterative method for the analysis of the ionized field around high-voltage bipolar direct-current (HVDC) transmission line conductors without resort to Deutsch's assumption. A new iterative finite-element ballooning technique is proposed to solve Poisson's equation wherein the commonly used artificial boundary around the transmission line conductors is simulated at infinity. Unlike all attempts reported in the literature for the solution of ionized field, the constancy of the conductors' surface field at the corona onset value is directly implemented in the finite-element formulation. In order to investigate the effectiveness of the proposed method, a laboratory model was built. It has been found that the calculated V-I characteristics and the ground-plane current density agreed well with those measured experimentally. The simplicity in computer programming in addition to the low number of iterations required to achieve convergence characterize this method of analysis

  15. Straightened cervical lordosis causes stress concentration: a finite element model study

    Energy Technology Data Exchange (ETDEWEB)

    Wei, Wei; Shi, Shiyuan; Fei, Jun; Wang, Yifan; Chen, Chunyue [Hangzhou Red Cross Hospital, Hangzhou, Zhejiang, (China); Liao, Shenhui [School of Information Science and Engineering, Central South University, Changsha, Hunan (China)

    2013-03-15

    In this study, we propose a finite element analysis of the complete cervical spine with straightened and normal physiological curvature by using a specially designed modelling system. An accurate finite element model is established to recommend plausible approaches to treatment of cervical spondylosis through the finite element analysis results. There are few reports of biomechanics influence of the straightened cervical curve. It is difficult to measure internal responses of cervical spine directly. However, the finite element method has been reported to have the capability to quantify both external and internal responses to mechanical loading, such as the strain and stress distribution of spinal components. We choose a subject with a straightened cervical spine from whom to collect the CT scan data, which formed the basis of the finite element analysis. By using a specially designed modelling system, a high quality finite element model of the complete cervical spine with straightened curvature was generated, which was then mapped to reconstruct a normal physiological curvature model by a volumetric mesh deformation method based on discrete differential properties. Then, the same boundary conditions were applied to do a comparison. The result demonstrated that the active movement range of straightened cervical spine decreased by 24–33 %, but the stress increased by 5–95 %. The stress was concentrated at the facet joint cartilage, uncovertebral joint and the disk. The results suggest that cervical lordosis may have a direct impact on cervical spondylosis treatment. These results may be useful for clinical treatment of cervical spondylosis with straightened curvature.

  16. Straightened cervical lordosis causes stress concentration: a finite element model study

    International Nuclear Information System (INIS)

    Wei, Wei; Shi, Shiyuan; Fei, Jun; Wang, Yifan; Chen, Chunyue; Liao, Shenhui

    2013-01-01

    In this study, we propose a finite element analysis of the complete cervical spine with straightened and normal physiological curvature by using a specially designed modelling system. An accurate finite element model is established to recommend plausible approaches to treatment of cervical spondylosis through the finite element analysis results. There are few reports of biomechanics influence of the straightened cervical curve. It is difficult to measure internal responses of cervical spine directly. However, the finite element method has been reported to have the capability to quantify both external and internal responses to mechanical loading, such as the strain and stress distribution of spinal components. We choose a subject with a straightened cervical spine from whom to collect the CT scan data, which formed the basis of the finite element analysis. By using a specially designed modelling system, a high quality finite element model of the complete cervical spine with straightened curvature was generated, which was then mapped to reconstruct a normal physiological curvature model by a volumetric mesh deformation method based on discrete differential properties. Then, the same boundary conditions were applied to do a comparison. The result demonstrated that the active movement range of straightened cervical spine decreased by 24–33 %, but the stress increased by 5–95 %. The stress was concentrated at the facet joint cartilage, uncovertebral joint and the disk. The results suggest that cervical lordosis may have a direct impact on cervical spondylosis treatment. These results may be useful for clinical treatment of cervical spondylosis with straightened curvature.

  17. Finite element model for heat conduction in jointed rock masses

    International Nuclear Information System (INIS)

    Gartling, D.K.; Thomas, R.K.

    1981-01-01

    A computatonal procedure for simulating heat conduction in a fractured rock mass is proposed and illustrated in the present paper. The method makes use of a simple local model for conduction in the vicinity of a single open fracture. The distributions of fractures and fracture properties within the finite element model are based on a statistical representation of geologic field data. Fracture behavior is included in the finite element computation by locating local, discrete fractures at the element integration points

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

  19. Mixed finite element - discontinuous finite volume element discretization of a general class of multicontinuum models

    Science.gov (United States)

    Ruiz-Baier, Ricardo; Lunati, Ivan

    2016-10-01

    We present a novel discretization scheme tailored to a class of multiphase models that regard the physical system as consisting of multiple interacting continua. In the framework of mixture theory, we consider a general mathematical model that entails solving a system of mass and momentum equations for both the mixture and one of the phases. The model results in a strongly coupled and nonlinear system of partial differential equations that are written in terms of phase and mixture (barycentric) velocities, phase pressure, and saturation. We construct an accurate, robust and reliable hybrid method that combines a mixed finite element discretization of the momentum equations with a primal discontinuous finite volume-element discretization of the mass (or transport) equations. The scheme is devised for unstructured meshes and relies on mixed Brezzi-Douglas-Marini approximations of phase and total velocities, on piecewise constant elements for the approximation of phase or total pressures, as well as on a primal formulation that employs discontinuous finite volume elements defined on a dual diamond mesh to approximate scalar fields of interest (such as volume fraction, total density, saturation, etc.). As the discretization scheme is derived for a general formulation of multicontinuum physical systems, it can be readily applied to a large class of simplified multiphase models; on the other, the approach can be seen as a generalization of these models that are commonly encountered in the literature and employed when the latter are not sufficiently accurate. An extensive set of numerical test cases involving two- and three-dimensional porous media are presented to demonstrate the accuracy of the method (displaying an optimal convergence rate), the physics-preserving properties of the mixed-primal scheme, as well as the robustness of the method (which is successfully used to simulate diverse physical phenomena such as density fingering, Terzaghi's consolidation

  20. hpGEM -- A software framework for discontinuous Galerkin finite element methods

    NARCIS (Netherlands)

    Pesch, L.; Bell, A.; Sollie, W.E.H.; Ambati, V.R.; Bokhove, Onno; van der Vegt, Jacobus J.W.

    2006-01-01

    hpGEM, a novel framework for the implementation of discontinuous Galerkin finite element methods, is described. We present structures and methods that are common for many (discontinuous) finite element methods and show how we have implemented the components as an object-oriented framework. This

  1. Orthodontic treatment: Introducing finite element analysis

    NARCIS (Netherlands)

    Driel, W.D. van; Leeuwen, E.J. van

    1998-01-01

    The aim of orthodontic treatment is the displacement of teeth by means ofspecial appliances, like braces and brackets. Through these appliances the orthodontist can apply a set of forces to the teeth which wilt result in its displacement through the jawbone. Finite Element analysis of this process

  2. A finite element modeling method for predicting long term corrosion rates

    International Nuclear Information System (INIS)

    Fu, J.W.; Chan, S.

    1984-01-01

    For the analyses of galvanic corrosion, pitting and crevice corrosion, which have been identified as possible corrosion processes for nuclear waste isolation, a finite element method has been developed for the prediction of corrosion rates. The method uses a finite element mesh to model the corrosive environment and the polarization curves of metals are assigned as the boundary conditions to calculate the corrosion cell current distribution. A subroutine is used to calculate the chemical change with time in the crevice or the pit environments. In this paper, the finite element method is described along with experimental confirmation

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

    Energy Technology Data Exchange (ETDEWEB)

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

    1994-12-31

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

  4. Introduction to nonlinear finite element analysis

    CERN Document Server

    Kim, Nam-Ho

    2015-01-01

    This book introduces the key concepts of nonlinear finite element analysis procedures. The book explains the fundamental theories of the field and provides instructions on how to apply the concepts to solving practical engineering problems. Instead of covering many nonlinear problems, the book focuses on three representative problems: nonlinear elasticity, elastoplasticity, and contact problems. The book is written independent of any particular software, but tutorials and examples using four commercial programs are included as appendices: ANSYS, NASTRAN, ABAQUS, and MATLAB. In particular, the MATLAB program includes all source codes so that students can develop their own material models, or different algorithms. This book also: ·         Presents clear explanations of nonlinear finite element analysis for elasticity, elastoplasticity, and contact problems ·         Includes many informative examples of nonlinear analyses so that students can clearly understand the nonlinear theory ·    ...

  5. Finite element analysis of multilayer coextrusion.

    Energy Technology Data Exchange (ETDEWEB)

    Hopkins, Matthew Morgan; Schunk, Peter Randall; Baer, Thomas A. (Proctor & Gamble Company, West Chester, OH); Mrozek, Randy A. (Army Research Laboratory, Adelphi, MD); Lenhart, Joseph Ludlow (Army Research Laboratory, Adelphi, MD); Rao, Rekha Ranjana; Collins, Robert (Oak Ridge National Laboratory); Mondy, Lisa Ann

    2011-09-01

    Multilayer coextrusion has become a popular commercial process for producing complex polymeric products from soda bottles to reflective coatings. A numerical model of a multilayer coextrusion process is developed based on a finite element discretization and two different free-surface methods, an arbitrary-Lagrangian-Eulerian (ALE) moving mesh implementation and an Eulerian level set method, to understand the moving boundary problem associated with the polymer-polymer interface. The goal of this work is to have a numerical capability suitable for optimizing and troubleshooting the coextrusion process, circumventing flow instabilities such as ribbing and barring, and reducing variability in layer thickness. Though these instabilities can be both viscous and elastic in nature, for this work a generalized Newtonian description of the fluid is used. Models of varying degrees of complexity are investigated including stability analysis and direct three-dimensional finite element free surface approaches. The results of this work show how critical modeling can be to reduce build test cycles, improve material choices, and guide mold design.

  6. Finite element analysis of ARPS structures

    International Nuclear Information System (INIS)

    Ruhkamp, J.D.; McDougal, J.R.; Kramer, D.P.

    1998-01-01

    Algor finite element software was used to determine the stresses and deflections in the metallic walls of Advanced Radioisotope Power Systems (ARPS) designs. The preliminary design review of these systems often neglects the structural integrity of the design which can effect fabrication and the end use of the design. Before finite element analysis (FEA) was run on the canister walls of the thermophotovoltaic (TPV) generator, hand calculations were used to approximate the stresses and deflections in a flat plate. These results compared favorably to the FEA results of a similar size flat plate. The AMTEC (Alkali Metal Thermal-to-Electric Conversion) cells were analyzed by FEA and the results compared to two cells that were mechanically tested. The mechanically tested cells buckled in the thin sections, one at the top and one in the lower section. The FEA predicted similar stress and shape results but the critical buckling load was found to be very shape dependent

  7. A short summary on finite element modelling of fatigue crack closure

    Energy Technology Data Exchange (ETDEWEB)

    Singh, Konjengbam Darunkumar [Indian Institute of Technology, Guwahati (India); Parry, Matthew Roger [Airbus Operations Ltd, Bristol(United Kingdom); Sinclair, Ian [University of Southampton, Southampton (United Kingdom)

    2011-12-15

    This paper presents a short summary pertaining to the finite element modelling of fatigue crack closure. Several key issues related to finite element modelling of fatigue crack closure are highlighted: element type, mesh refinement, stabilization of crack closure, crack-tip node release scheme, constitutive model, specimen geometry, stress-states (i.e., plane stress, plane strain), crack closure monitoring. Reviews are presented for both straight and deflected cracks.

  8. Overlapping Schwarz for Nonlinear Problems. An Element Agglomeration Nonlinear Additive Schwarz Preconditioned Newton Method for Unstructured Finite Element Problems

    Energy Technology Data Exchange (ETDEWEB)

    Cai, X C; Marcinkowski, L; Vassilevski, P S

    2005-02-10

    This paper extends previous results on nonlinear Schwarz preconditioning ([4]) to unstructured finite element elliptic problems exploiting now nonlocal (but small) subspaces. The non-local finite element subspaces are associated with subdomains obtained from a non-overlapping element partitioning of the original set of elements and are coarse outside the prescribed element subdomain. The coarsening is based on a modification of the agglomeration based AMGe method proposed in [8]. Then, the algebraic construction from [9] of the corresponding non-linear finite element subproblems is applied to generate the subspace based nonlinear preconditioner. The overall nonlinearly preconditioned problem is solved by an inexact Newton method. Numerical illustration is also provided.

  9. Generalized multiscale finite element methods: Oversampling strategies

    KAUST Repository

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

    2014-01-01

    In this paper, we propose oversampling strategies in the generalized multiscale finite element method (GMsFEM) framework. The GMsFEM, which has been recently introduced in Efendiev et al. (2013b) [Generalized Multiscale Finite Element Methods, J. Comput. Phys., vol. 251, pp. 116-135, 2013], allows solving multiscale parameter-dependent problems at a reduced computational cost by constructing a reduced-order representation of the solution on a coarse grid. The main idea of the method consists of (1) the construction of snapshot space, (2) the construction of the offline space, and (3) construction of the online space (the latter for parameter-dependent problems). In Efendiev et al. (2013b) [Generalized Multiscale Finite Element Methods, J. Comput. Phys., vol. 251, pp. 116-135, 2013], it was shown that the GMsFEM provides a flexible tool to solve multiscale problems with a complex input space by generating appropriate snapshot, offline, and online spaces. In this paper, we develop oversampling techniques to be used in this context (see Hou and Wu (1997) where oversampling is introduced for multiscale finite element methods). It is known (see Hou and Wu (1997)) that the oversampling can improve the accuracy of multiscale methods. In particular, the oversampling technique uses larger regions (larger than the target coarse block) in constructing local basis functions. Our motivation stems from the analysis presented in this paper, which shows that when using oversampling techniques in the construction of the snapshot space and offline space, GMsFEM will converge independent of small scales and high contrast under certain assumptions. We consider the use of a multiple eigenvalue problems to improve the convergence and discuss their relation to single spectral problems that use oversampled regions. The oversampling procedures proposed in this paper differ from those in Hou and Wu (1997). In particular, the oversampling domains are partially used in constructing local

  10. Groundwater flow analysis using mixed hybrid finite element method for radioactive waste disposal facilities

    International Nuclear Information System (INIS)

    Aoki, Hiroomi; Shimomura, Masanori; Kawakami, Hiroto; Suzuki, Shunichi

    2011-01-01

    In safety assessments of radioactive waste disposal facilities, ground water flow analysis are used for calculating the radionuclide transport pathway and the infiltration flow rate of groundwater into the disposal facilities. For this type of calculations, the mixed hybrid finite element method has been used and discussed about the accuracy of ones in Europe. This paper puts great emphasis on the infiltration flow rate of groundwater into the disposal facilities, and describes the accuracy of results obtained from mixed hybrid finite element method by comparing of local water mass conservation and the reliability of the element breakdown numbers among the mixed hybrid finite element method, finite volume method and nondegenerated finite element method. (author)

  11. Finite element elastic-plastic analysis of LMFBR components

    International Nuclear Information System (INIS)

    Levy, A.; Pifko, A.; Armen, H. Jr.

    1978-01-01

    The present effort involves the development of computationally efficient finite element methods for accurately predicting the isothermal elastic-plastic three-dimensional response of thick and thin shell structures subjected to mechanical and thermal loads. This work will be used as the basis for further development of analytical tools to be used to verify the structural integrity of liquid metal fast breeder reactor (LMFBR) components. The methods presented here have been implemented into the three-dimensional solid element module (HEX) of the Grumman PLANS finite element program. These methods include the use of optimal stress points as well as a variable number of stress points within an element. This allows monitoring the stress history at many points within an element and hence provides an accurate representation of the elastic-plastic boundary using a minimum number of degrees of freedom. Also included is an improved thermal stress analysis capability in which the temperature variation and corresponding thermal strain variation are represented by the same functional form as the displacement variation. Various problems are used to demonstrate these improved capabilities. (Auth.)

  12. Level set methods for detonation shock dynamics using high-order finite elements

    Energy Technology Data Exchange (ETDEWEB)

    Dobrev, V. A. [Lawrence Livermore National Lab. (LLNL), Livermore, CA (United States); Grogan, F. C. [Univ. of California, San Diego, CA (United States); Lawrence Livermore National Lab. (LLNL), Livermore, CA (United States); Kolev, T. V. [Lawrence Livermore National Lab. (LLNL), Livermore, CA (United States); Rieben, R [Lawrence Livermore National Lab. (LLNL), Livermore, CA (United States); Tomov, V. Z. [Lawrence Livermore National Lab. (LLNL), Livermore, CA (United States)

    2017-05-26

    Level set methods are a popular approach to modeling evolving interfaces. We present a level set ad- vection solver in two and three dimensions using the discontinuous Galerkin method with high-order nite elements. During evolution, the level set function is reinitialized to a signed distance function to maintain ac- curacy. Our approach leads to stable front propagation and convergence on high-order, curved, unstructured meshes. The ability of the solver to implicitly track moving fronts lends itself to a number of applications; in particular, we highlight applications to high-explosive (HE) burn and detonation shock dynamics (DSD). We provide results for two- and three-dimensional benchmark problems as well as applications to DSD.

  13. Finite Element Residual Stress Analysis of Planetary Gear Tooth

    Directory of Open Access Journals (Sweden)

    Jungang Wang

    2013-01-01

    Full Text Available A method to simulate residual stress field of planetary gear is proposed. In this method, the finite element model of planetary gear is established and divided to tooth zone and profile zone, whose different temperature field is set. The gear's residual stress simulation is realized by the thermal compression stress generated by the temperature difference. Based on the simulation, the finite element model of planetary gear train is established, the dynamic meshing process is simulated, and influence of residual stress on equivalent stress of addendum, pitch circle, and dedendum of internal and external meshing planetary gear tooth profile is analyzed, according to non-linear contact theory, thermodynamic theory, and finite element theory. The results show that the equivalent stresses of planetary gear at both meshing and nonmeshing surface are significantly and differently reduced by residual stress. The study benefits fatigue cracking analysis and dynamic optimization design of planetary gear train.

  14. Finite element modeling of the filament winding process using ABAQUS

    OpenAIRE

    Miltenberger, Louis C.

    1992-01-01

    A comprehensive stress model of the filament winding fabrication process, previously implemented in the finite element program, WACSAFE, was implemented using the ABAQUS finite element software package. This new implementation, referred to as the ABWACSAFE procedure, consists of the ABAQUS software and a pre/postprocessing routine that was developed to prepare necessary ABAQUS input files and process ABAQUS displacement results for stress and strain computation. The ABWACSAF...

  15. Finite element reliability analysis of fatigue life

    International Nuclear Information System (INIS)

    Harkness, H.H.; Belytschko, T.; Liu, W.K.

    1992-01-01

    Fatigue reliability is addressed by the first-order reliability method combined with a finite element method. Two-dimensional finite element models of components with cracks in mode I are considered with crack growth treated by the Paris law. Probability density functions of the variables affecting fatigue are proposed to reflect a setting where nondestructive evaluation is used, and the Rosenblatt transformation is employed to treat non-Gaussian random variables. Comparisons of the first-order reliability results and Monte Carlo simulations suggest that the accuracy of the first-order reliability method is quite good in this setting. Results show that the upper portion of the initial crack length probability density function is crucial to reliability, which suggests that if nondestructive evaluation is used, the probability of detection curve plays a key role in reliability. (orig.)

  16. Java Based Symbolic Circuit Solver For Electrical Engineering Curriculum

    Directory of Open Access Journals (Sweden)

    Ruba Akram Amarin

    2012-11-01

    Full Text Available The interactive technical electronic book, TechEBook, currently under development at the University of Central Florida (UCF, introduces a paradigm shift by replacing the traditional electrical engineering course with topic-driven modules that provide a useful tool for engineers and scientists. The TechEBook comprises the two worlds of classical circuit books and interactive operating platforms such as iPads, laptops and desktops. The TechEBook provides an interactive applets screen that holds many modules, each of which has a specific application in the self learning process. This paper describes one of the interactive techniques in the TechEBook known as Symbolic Circuit Solver (SymCirc. The SymCirc develops a versatile symbolic based linear circuit with a switches solver. The solver works by accepting a Netlist and the element that the user wants to find the voltage across or current on, as input parameters. Then it either produces the plot or the time domain expression of the output. Frequency domain plots or Symbolic Transfer Functions are also produced. The solver gets its input from a Web-based GUI circuit drawer developed at UCF. Typical simulation tools that electrical engineers encounter are numerical in nature, that is, when presented with an input circuit they iteratively solve the circuit across a set of small time steps. The result is represented as a data set of output versus time, which can be plotted for further inspection. Such results do not help users understand the ultimate nature of circuits as Linear Time Invariant systems with a finite dimensional basis in the solution space. SymCirc provides all simulation results as time domain expressions composed of the basic functions that exclusively include exponentials, sines, cosines and/or t raised to any power. This paper explains the motivation behind SymCirc, the Graphical User Interface front end and how the solver actually works. The paper also presents some examples and

  17. Stochastic Finite Elements in Reliability-Based Structural Optimization

    DEFF Research Database (Denmark)

    Sørensen, John Dalsgaard; Engelund, S.

    1995-01-01

    Application of stochastic finite elements in structural optimization is considered. It is shown how stochastic fields modelling e.g. the modulus of elasticity can be discretized in stochastic variables and how a sensitivity analysis of the reliability of a structural system with respect to optimi......Application of stochastic finite elements in structural optimization is considered. It is shown how stochastic fields modelling e.g. the modulus of elasticity can be discretized in stochastic variables and how a sensitivity analysis of the reliability of a structural system with respect...... to optimization variables can be performed. A computer implementation is described and an illustrative example is given....

  18. Finite element electromagnetic field computation on the Sequent Symmetry 81 parallel computer

    International Nuclear Information System (INIS)

    Ratnajeevan, S.; Hoole, H.

    1990-01-01

    Finite element field analysis algorithms lend themselves to parallelization and this fact is exploited in this paper to implement a finite element analysis program for electromagnetic field computation on the Sequent Symmetry 81 parallel computer with three processors. In terms of waiting time, the maximum gains are to be made in matrix solution and therefore this paper concentrates on the gains in parallelizing the solution part of finite element analysis. An outline of how parallelization could be exploited in most finite element operations is given in this paper although the actual implemention of parallelism on the Sequent Symmetry 81 parallel computer was in sparsity computation, matrix assembly and the matrix solution areas. In all cases, the algorithms were modified suit the parallel programming application rather than allowing the compiler to parallelize on existing algorithms

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

    International Nuclear Information System (INIS)

    Fochesato, Ch.; Bouche, D.

    2007-01-01

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

  20. Finite element model updating of natural fibre reinforced composite structure in structural dynamics

    Directory of Open Access Journals (Sweden)

    Sani M.S.M.

    2016-01-01

    Full Text Available Model updating is a process of making adjustment of certain parameters of finite element model in order to reduce discrepancy between analytical predictions of finite element (FE and experimental results. Finite element model updating is considered as an important field of study as practical application of finite element method often shows discrepancy to the test result. The aim of this research is to perform model updating procedure on a composite structure as well as trying improving the presumed geometrical and material properties of tested composite structure in finite element prediction. The composite structure concerned in this study is a plate of reinforced kenaf fiber with epoxy. Modal properties (natural frequency, mode shapes, and damping ratio of the kenaf fiber structure will be determined using both experimental modal analysis (EMA and finite element analysis (FEA. In EMA, modal testing will be carried out using impact hammer test while normal mode analysis using FEA will be carried out using MSC. Nastran/Patran software. Correlation of the data will be carried out before optimizing the data from FEA. Several parameters will be considered and selected for the model updating procedure.

  1. Synthesis of hydrocode and finite element technology for large deformation Lagrangian computation

    International Nuclear Information System (INIS)

    Goudreau, G.L.; Hallquist, J.O.

    1979-08-01

    Large deformation engineering analysis at Lawrence Livermore Laboratory has benefited from a synthesis of computational technology from the finite difference hydrocodes of the scientific weapons community and the structural finite element methodology of engineering. Two- and three-dimensional explicit and implicit Lagrangian continuum codes have been developed exploiting the strengths of each. The explicit methodology primarily exploits the primitive constant stress (or one point integration) brick element. Similarity and differences with the integral finite difference method are discussed. Choice of stress and finite strain measures, and selection of hour glass viscosity are also considered. The implicit codes also employ a Cauchy formulation, with Newton iteration and a symmetric tangent matrix. A library of finite strain material routines includes hypoelastic/plastic, hyperelastic, viscoelastic, as well as hydrodynamic behavior. Arbitrary finite element topology and a general slide-line treatment significantly extends Lagrangian hydrocode application. Computational experience spans weapons and non-weapons applications

  2. Advanced finite element method in structural engineering

    CERN Document Server

    Long, Yu-Qiu; Long, Zhi-Fei

    2009-01-01

    This book systematically introduces the research work on the Finite Element Method completed over the past 25 years. Original theoretical achievements and their applications in the fields of structural engineering and computational mechanics are discussed.

  3. Optical Finite Element Processor

    Science.gov (United States)

    Casasent, David; Taylor, Bradley K.

    1986-01-01

    A new high-accuracy optical linear algebra processor (OLAP) with many advantageous features is described. It achieves floating point accuracy, handles bipolar data by sign-magnitude representation, performs LU decomposition using only one channel, easily partitions and considers data flow. A new application (finite element (FE) structural analysis) for OLAPs is introduced and the results of a case study presented. Error sources in encoded OLAPs are addressed for the first time. Their modeling and simulation are discussed and quantitative data are presented. Dominant error sources and the effects of composite error sources are analyzed.

  4. Investigation of the Behavior of Steel Shear Walls Using Finite Elements Analysis

    Directory of Open Access Journals (Sweden)

    K. Abubakri

    2016-10-01

    Full Text Available Currently, steel shear walls are considered by engineers as an economic method against lateral loads imposed by wind and earthquake in tall structures. Accordingly, there is a growing need to develop accurate methods alongside approximation methods to estimate the behavior of these structural elements. The finite element technique is one of the strongest numerical methods in analysis of solid mechanics problems. Finite element analysis however requires high technical knowledge of the behavioral models of materials. Therefore, it is less used by designers for certain structural elements such as steel shear walls. This study examines the failure mechanism of steel shear walls using finite elements analysis and validates this modeling by comparing the results with experimental studies.

  5. Matlab and C programming for Trefftz finite element methods

    CERN Document Server

    Qin, Qing-Hua

    2008-01-01

    Although the Trefftz finite element method (FEM) has become a powerful computational tool in the analysis of plane elasticity, thin and thick plate bending, Poisson's equation, heat conduction, and piezoelectric materials, there are few books that offer a comprehensive computer programming treatment of the subject. Collecting results scattered in the literature, MATLAB® and C Programming for Trefftz Finite Element Methods provides the detailed MATLAB® and C programming processes in applications of the Trefftz FEM to potential and elastic problems. The book begins with an introduction to th

  6. Preconditioning for Mixed Finite Element Formulations of Elliptic Problems

    KAUST Repository

    Wildey, Tim; Xue, Guangri

    2013-01-01

    In this paper, we discuss a preconditioning technique for mixed finite element discretizations of elliptic equations. The technique is based on a block-diagonal approximation of the mass matrix which maintains the sparsity and positive definiteness of the corresponding Schur complement. This preconditioner arises from the multipoint flux mixed finite element method and is robust with respect to mesh size and is better conditioned for full permeability tensors than a preconditioner based on a diagonal approximation of the mass matrix. © Springer-Verlag Berlin Heidelberg 2013.

  7. 3D CSEM inversion based on goal-oriented adaptive finite element method

    Science.gov (United States)

    Zhang, Y.; Key, K.

    2016-12-01

    We present a parallel 3D frequency domain controlled-source electromagnetic inversion code name MARE3DEM. Non-linear inversion of observed data is performed with the Occam variant of regularized Gauss-Newton optimization. The forward operator is based on the goal-oriented finite element method that efficiently calculates the responses and sensitivity kernels in parallel using a data decomposition scheme where independent modeling tasks contain different frequencies and subsets of the transmitters and receivers. To accommodate complex 3D conductivity variation with high flexibility and precision, we adopt the dual-grid approach where the forward mesh conforms to the inversion parameter grid and is adaptively refined until the forward solution converges to the desired accuracy. This dual-grid approach is memory efficient, since the inverse parameter grid remains independent from fine meshing generated around the transmitter and receivers by the adaptive finite element method. Besides, the unstructured inverse mesh efficiently handles multiple scale structures and allows for fine-scale model parameters within the region of interest. Our mesh generation engine keeps track of the refinement hierarchy so that the map of conductivity and sensitivity kernel between the forward and inverse mesh is retained. We employ the adjoint-reciprocity method to calculate the sensitivity kernels which establish a linear relationship between changes in the conductivity model and changes in the modeled responses. Our code uses a direcy solver for the linear systems, so the adjoint problem is efficiently computed by re-using the factorization from the primary problem. Further computational efficiency and scalability is obtained in the regularized Gauss-Newton portion of the inversion using parallel dense matrix-matrix multiplication and matrix factorization routines implemented with the ScaLAPACK library. We show the scalability, reliability and the potential of the algorithm to deal with

  8. Finite volume method for radiative heat transfer in an unstructured flow solver for emitting, absorbing and scattering media

    International Nuclear Information System (INIS)

    Gazdallah, Moncef; Feldheim, Véronique; Claramunt, Kilian; Hirsch, Charles

    2012-01-01

    This paper presents the implementation of the finite volume method to solve the radiative transfer equation in a commercial code. The particularity of this work is that the method applied on unstructured hexahedral meshes does not need a pre-processing step establishing a particular marching order to visit all the control volumes. The solver simply visits the faces of the control volumes as numbered in the hexahedral unstructured mesh. A cell centred mesh and a spatial differencing step scheme to relate facial radiative intensities to nodal intensities is used. The developed computer code based on FVM has been integrated in the CFD solver FINE/Open from NUMECA Int. Radiative heat transfer can be evaluated within systems containing uniform, grey, emitting, absorbing and/or isotropically or linear anisotropically scattering medium bounded by diffuse grey walls. This code has been validated for three test cases. The first one is a three dimensional rectangular enclosure filled with emitting, absorbing and anisotropically scattering media. The second is the differentially heated cubic cavity. The third one is the L-shaped enclosure. For these three test cases a good agreement has been observed when temperature and heat fluxes predictions are compared with references taken, from literature.

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

    KAUST Repository

    Efendiev, Y.

    2012-08-01

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

  10. Investigation of faulted tunnel models by combined photoelasticity and finite element analysis

    International Nuclear Information System (INIS)

    Ladkany, S.G.; Huang, Yuping

    1994-01-01

    Models of square and circular tunnels with short faults cutting through their surfaces are investigated by photoelasticity. These models, when duplicated by finite element analysis can predict the stress states of square or circular faulted tunnels adequately. Finite element analysis, using gap elements, may be used to investigate full size faulted tunnel system

  11. Simple one-dimensional finite element algorithm with multi-dimensional capabilities

    International Nuclear Information System (INIS)

    Pepper, D.W.; Baker, A.J.

    1978-01-01

    The application of the finite element procedure for the solution of partial differential equations is gaining widespread acceptance. The ability of the finite element procedure to solve problems which are arbitrarily shaped as well as the alleviation of boundary condition problems is well known. By using local interpolation functionals over each subdomain, or element, a set of linearized algebraic equations are obtained which can be solved using any direct, iterative, or inverse numerical technique. Subsequent use of an explicit or implicit integration procedure permits closure of the solution over the global domain

  12. Review on Finite Element Method * ERHUNMWUN, ID ...

    African Journals Online (AJOL)

    ADOWIE PERE

    ABSTRACT: In this work, we have discussed what Finite Element Method (FEM) is, its historical development, advantages and ... residual procedures, are examples of the direct approach ... The paper centred on the "stiffness and deflection of ...

  13. Finite element evaluation of erosion/corrosion affected reducing elbow

    International Nuclear Information System (INIS)

    Basavaraju, C.

    1996-01-01

    Erosion/corrosion is a primary source for wall thinning or degradation of carbon steel piping systems in service. A number of piping failures in the power industry have been attributed to erosion/corrosion. Piping elbow is one of such susceptible components for erosion/corrosion because of increased flow turbulence due to its geometry. In this paper, the acceptability of a 12 in. x 8 in. reducing elbow in RHR service water pump discharge piping, which experienced significant degradation due to wall thinning in localized areas, was evaluated using finite element analysis methodology. Since the simplified methods showed very small margin and recommended replacement of the elbow, a detailed 3-D finite element model was built using shell elements and analyzed for internal pressure and moment loadings. The finite element analysis incorporated the U.T. measured wall thickness data at various spots that experienced wall thinning. The results showed that the elbow is acceptable as-is until the next fuel cycle. FEA, though cumbersome, and time consuming is a valuable analytical tool in making critical decisions with regard to component replacement of border line situation cases, eliminating some conservatism while not compromising the safety

  14. Extended finite element method and its application in heterogeneous materials with inclusions

    International Nuclear Information System (INIS)

    Du Chengbin; Jiang Shouyan; Ying Zongquan

    2010-01-01

    To simplify the technology of finite element mesh generation for particle reinforced material, enrichment techniques is used to account for the material interfaces in the framework of extended finite element method (XFEM). The geometry of material distribution is described by level set function, which allows one to model the internal boundaries of the microstructure without the adaptation of the mesh. The enrichment function is used to improve the shape function of classical finite element method (FEM) for the nodes supporting the elements cut by the interface. The key issue of XFEM including constructing displacement pattern, establishment of the governing equation and scheme of numerical integration is also presented. It is not necessarily matching the internal features of the inclusions using XFEM, so the generation of finite element mesh can be performed easily. Finally, a plate with multi-circular inclusions under uniaxial tension is simulated by XFEM and FEM, respectively. The results show that XFEM is highly effective and efficient.

  15. Behaviour of Lagrangian triangular mixed fluid finite elements

    Indian Academy of Sciences (India)

    The behaviour of mixed fluid finite elements, formulated based on the Lagrangian frame of reference, is investigated to understand the effects of locking due to incompressibility and irrotational constraints. For this purpose, both linear and quadratic mixed triangular fluid elements are formulated. It is found that there exists a ...

  16. A fully coupled finite element framework for thermal fracturing simulation in subsurface cold CO2 injection

    Directory of Open Access Journals (Sweden)

    Shunde Yin

    2018-03-01

    Simulation of thermal fracturing during cold CO2 injection involves the coupled processes of heat transfer, mass transport, rock deforming as well as fracture propagation. To model such a complex coupled system, a fully coupled finite element framework for thermal fracturing simulation is presented. This framework is based on the theory of non-isothermal multiphase flow in fracturing porous media. It takes advantage of recent advances in stabilized finite element and extended finite element methods. The stabilized finite element method overcomes the numerical instability encountered when the traditional finite element method is used to solve the convection dominated heat transfer equation, while the extended finite element method overcomes the limitation with traditional finite element method that a model has to be remeshed when a fracture is initiated or propagating and fracturing paths have to be aligned with element boundaries.

  17. Finite element modelling of solidification phenomena

    Indian Academy of Sciences (India)

    Unknown

    Abstract. The process of solidification process is complex in nature and the simulation of such process is required in industry before it is actually undertaken. Finite element method is used to simulate the heat transfer process accompanying the solidification process. The metal and the mould along with the air gap formation ...

  18. An object-oriented 3D nodal finite element solver for neutron transport calculations in the Descartes project

    Energy Technology Data Exchange (ETDEWEB)

    Akherraz, B.; Lautard, J.J. [CEA Saclay, Dept. Modelisation de Systemes et Structures, Serv. d' Etudes des Reacteurs et de Modelisation Avancee (DMSS/SERMA), 91 - Gif sur Yvette (France); Erhard, P. [Electricite de France (EDF), Dir. de Recherche et Developpement, Dept. Sinetics, 92 - Clamart (France)

    2003-07-01

    In this paper we present two applications of the Nodal finite elements developed by Hennart and del Valle, first to three-dimensional Cartesian meshes and then to two-dimensional Hexagonal meshes. This work has been achieved within the framework of the DESCARTES project, which is a co-development effort by the 'Commissariat a l'Energie Atomique' (CEA) and 'Electricite de France' (EDF) for the development of a toolbox for reactor core calculations based on object oriented programming. The general structure of this project is based on the object oriented method. By using a mapping technique proposed in Schneider's thesis and del Valle, Mund, we show how this structuration allows us an easy implementation of the hexagonal case from the Cartesian case. The main attractiveness of this methodology is the possibility of a pin-by-pin representation by division of each lozenge into smaller ones. Furthermore, we will explore the use of non structured quadrangles to treat the circular geometry within a hexagon. It remains nevertheless, in the hexagonal case, the implementation of the acceleration of the internal iterations by the DSA (Diffusion Synthetic Acceleration) or the TSA. (authors)

  19. Pengenalan Ababil: Program Finite Element Analysis (FEA 3-Dimensi Untuk Struktur Rangka-Batang

    Directory of Open Access Journals (Sweden)

    Sugeng Waluyo

    2011-02-01

    Full Text Available Ababil is an open source computer program working on the basis offinite element method (FEM which is aimed to analyze frame structures. It is mainly designed as a solver without embedded pre-or/and post-processing units. Recently, the solver is compatible only for reading and writing in the Gmsh [1] pre- and post-processing software environment. The FEM kinematics formulation applied here is relied on the Timoshenko Beam Theory (TBT using linear shape function. Finally, the well-known FEM software MSC.Nastranis used to ensure the capability of Ababil in the prediction of frame deformation by means of FEMsimulation

  20. Energy flow in plate assembles by hierarchical version of finite element method

    DEFF Research Database (Denmark)

    Wachulec, Marcin; Kirkegaard, Poul Henning

    method has been proposed. In this paper a modified hierarchical version of finite element method is used for modelling of energy flow in plate assembles. The formulation includes description of in-plane forces so that planes lying in different planes can be modelled. Two examples considered are: L......The dynamic analysis of structures in medium and high frequencies are usually focused on frequency and spatial averages of energy of components, and not the displacement/velocity fields. This is especially true for structure-borne noise modelling. For the analysis of complicated structures...... the finite element method has been used to study the energy flow. The finite element method proved its usefulness despite the computational expense. Therefore studies have been conducted in order to simplify and reduce the computations required. Among others, the use of hierarchical version of finite element...

  1. Finite element bending behaviour of discretely delaminated ...

    African Journals Online (AJOL)

    user

    due to their light weight, high specific strength and stiffness properties. ... cylindrical shell roofs respectively using finite element method with centrally located .... where { }ε and { }γ are the direct and shear strains in midplane and { }κ denotes ...

  2. Multisymplectic Structure-Preserving in Simple Finite Element Method in High Dimensional Case

    Institute of Scientific and Technical Information of China (English)

    BAI Yong-Qiang; LIU Zhen; PEI Ming; ZHENG Zhu-Jun

    2003-01-01

    In this paper, we study a finite element scheme of some semi-linear elliptic boundary value problems inhigh-dimensional space. With uniform mesh, we find that, the numerical scheme derived from finite element method cankeep a preserved multisymplectic structure.

  3. Introduction to COFFE: The Next-Generation HPCMP CREATE-AV CFD Solver

    Science.gov (United States)

    Glasby, Ryan S.; Erwin, J. Taylor; Stefanski, Douglas L.; Allmaras, Steven R.; Galbraith, Marshall C.; Anderson, W. Kyle; Nichols, Robert H.

    2016-01-01

    HPCMP CREATE-AV Conservative Field Finite Element (COFFE) is a modular, extensible, robust numerical solver for the Navier-Stokes equations that invokes modularity and extensibility from its first principles. COFFE implores a flexible, class-based hierarchy that provides a modular approach consisting of discretization, physics, parallelization, and linear algebra components. These components are developed with modern software engineering principles to ensure ease of uptake from a user's or developer's perspective. The Streamwise Upwind/Petrov-Galerkin (SU/PG) method is utilized to discretize the compressible Reynolds-Averaged Navier-Stokes (RANS) equations tightly coupled with a variety of turbulence models. The mathematics and the philosophy of the methodology that makes up COFFE are presented.

  4. A Dual Super-Element Domain Decomposition Approach for Parallel Nonlinear Finite Element Analysis

    Science.gov (United States)

    Jokhio, G. A.; Izzuddin, B. A.

    2015-05-01

    This article presents a new domain decomposition method for nonlinear finite element analysis introducing the concept of dual partition super-elements. The method extends ideas from the displacement frame method and is ideally suited for parallel nonlinear static/dynamic analysis of structural systems. In the new method, domain decomposition is realized by replacing one or more subdomains in a "parent system," each with a placeholder super-element, where the subdomains are processed separately as "child partitions," each wrapped by a dual super-element along the partition boundary. The analysis of the overall system, including the satisfaction of equilibrium and compatibility at all partition boundaries, is realized through direct communication between all pairs of placeholder and dual super-elements. The proposed method has particular advantages for matrix solution methods based on the frontal scheme, and can be readily implemented for existing finite element analysis programs to achieve parallelization on distributed memory systems with minimal intervention, thus overcoming memory bottlenecks typically faced in the analysis of large-scale problems. Several examples are presented in this article which demonstrate the computational benefits of the proposed parallel domain decomposition approach and its applicability to the nonlinear structural analysis of realistic structural systems.

  5. Recent uses of the finite element method in design/analysis of CANDU fuel

    International Nuclear Information System (INIS)

    Tayal, M.; Lim, D.

    1985-06-01

    Finite element codes FEAST and ELESTRES have been used to show: that initial pellet density can have a significant effect on the probability of fuel defect near end cap welds; that sheath stresses/strains are highly multiaxial near circumferential ridges; and that the multiaxiality affects sheath integrity significantly. The finite element thermal code FEAT was used to redesign bearing pads to obtain lower temperture; this eliminated crevice corrosion. FEAT was also used to assess the influences of braze voids and of end flux peaking. These analyses involved complex geometries. By using finite elements, we could obtain accurate assessments economically and rapidly. Finite element codes are also being developed for bowing, diffusion, flow patterns, and stress corrosion cracking

  6. Numerical solution of recirculating flow by a simple finite element recursion relation

    Energy Technology Data Exchange (ETDEWEB)

    Pepper, D W; Cooper, R E

    1980-01-01

    A time-split finite element recursion relation, based on linear basis functions, is used to solve the two-dimensional equations of motion. Recirculating flow in a rectangular cavity and free convective flow in an enclosed container are analyzed. The relation has the advantage of finite element accuracy and finite difference speed and simplicity. Incorporating dissipation parameters in the functionals decreases numerical dispersion and improves phase lag.

  7. Fluid-structure finite-element vibrational analysis

    Science.gov (United States)

    Feng, G. C.; Kiefling, L.

    1974-01-01

    A fluid finite element has been developed for a quasi-compressible fluid. Both kinetic and potential energy are expressed as functions of nodal displacements. Thus, the formulation is similar to that used for structural elements, with the only differences being that the fluid can possess gravitational potential, and the constitutive equations for fluid contain no shear coefficients. Using this approach, structural and fluid elements can be used interchangeably in existing efficient sparse-matrix structural computer programs such as SPAR. The theoretical development of the element formulations and the relationships of the local and global coordinates are shown. Solutions of fluid slosh, liquid compressibility, and coupled fluid-shell oscillation problems which were completed using a temporary digital computer program are shown. The frequency correlation of the solutions with classical theory is excellent.

  8. Finite element analysis of degraded concrete structures - Workshop proceedings

    International Nuclear Information System (INIS)

    1999-09-01

    This workshop is related to the finite element analysis of degraded concrete structures. It is composed of three sessions. The first session (which title is: the use of finite element analysis in safety assessments) comprises six papers which titles are: Historical Development of Concrete Finite Element Modeling for Safety Evaluation of Accident-Challenged and Aging Concrete Structures; Experience with Finite Element Methods for Safety Assessments in Switzerland; Stress State Analysis of the Ignalina NPP Confinement System; Prestressed Containment: Behaviour when Concrete Cracking is Modelled; Application of FEA for Design and Support of NPP Containment in Russia; Verification Problems of Nuclear Installations Safety Software of Strength Analysis (NISS SA). The second session (title: concrete containment structures under accident loads) comprises seven papers which titles are: Two Application Examples of Concrete Containment Structures under Accident Load Conditions Using Finite Element Analysis; What Kind of Prediction for Leak rates for Nuclear Power Plant Containments in Accidental Conditions; Influence of Different Hypotheses Used in Numerical Models for Concrete At Elevated Temperatures on the Predicted Behaviour of NPP Core Catchers Under Severe Accident Conditions; Observations on the Constitutive Modeling of Concrete Under Multi-Axial States at Elevated Temperatures; Analyses of a Reinforced Concrete Containment with Liner Corrosion Damage; Program of Containment Concrete Control During Operation for the Temelin Nuclear Power Plant; Static Limit Load of a Deteriorated Hyperbolic Cooling Tower. The third session (concrete structures under extreme environmental load) comprised five papers which titles are: Shear Transfer Mechanism of RC Plates After Cracking; Seismic Back Calculation of an Auxiliary Building of the Nuclear Power Plant Muehleberg, Switzerland; Seismic Behaviour of Slightly Reinforced Shear Wall Structures; FE Analysis of Degraded Concrete

  9. Finite element analysis of adanced composite structures containing mechanically fastened joints

    International Nuclear Information System (INIS)

    Baumann, E.

    1982-01-01

    Although the usual engineering practice is to ignore joint effects in finite element models of overall structures, there are times when the inclusion of fastener effects in a model is necessary for accurate analysis. This paper describes some simple but accurate methods for accommodating this modeling requirement. The approach involves correlation of test results from a few composite mechanically fastened joints with finite element analyses of joints. It is assumed that if the fastener actions in the test articles can be properly predicted by simple finite element techniques, then these same techniques can be applied to large overall structure models. During the course of this test-analysis effort it was determined that it is possible to obtain correct results for overall structure-joint analyses by using simple modeling concepts provided special care is employed. Also, some emphasis is given in this paper to the importance of properly reducing test data in order to obtain meaningful correlations with finite element analysis. Finally, for those interested, the appendix contains brief descriptions of the test results and failure modes explored in the test program. (orig.)

  10. Multisymplectic Structure-Preserving in Simple Finite Element Method in High Dimensional Case

    Institute of Scientific and Technical Information of China (English)

    BAIYong-Qiang; LIUZhen; PEIMing; ZHENGZhu-Jun

    2003-01-01

    In this paper, we study a finite element scheme of some semi-linear elliptic boundary value problems in high-dhnensjonal space. With uniform mesh, we find that, the numerical scheme derived from finite element method can keep a preserved multisymplectic structure.

  11. A Finite Element Analysis of Optimal Variable Thickness Sheets

    DEFF Research Database (Denmark)

    Petersson, Joakim S

    1996-01-01

    A quasimixed Finite Element (FE) method for maximum stiffness of variablethickness sheets is analysed. The displacement is approximated with ninenode Lagrange quadrilateral elements and the thickness is approximated aselementwise constant. One is guaranteed that the FE displacement solutionswill ...

  12. Performance and scalability of finite-difference and finite-element wave-propagation modeling on Intel's Xeon Phi

    NARCIS (Netherlands)

    Zhebel, E.; Minisini, S.; Kononov, A.; Mulder, W.A.

    2013-01-01

    With the rapid developments in parallel compute architectures, algorithms for seismic modeling and imaging need to be reconsidered in terms of parallelization. The aim of this paper is to compare scalability of seismic modeling algorithms: finite differences, continuous mass-lumped finite elements

  13. Thermal stresses in rectangular plates: variational and finite element solutions

    International Nuclear Information System (INIS)

    Laura, P.A.A.; Gutierrez, R.H.; Sanchez Sarmiento, G.; Basombrio, F.G.

    1978-01-01

    This paper deals with the development of an approximate method for the analysis of thermal stresses in rectangular plates (plane stress problem) and an evaluation of the relative accuracy of the finite element method. The stress function is expanded in terms of polynomial coordinate functions which identically satisfy the boundary conditions, and a variational approach is used to determine the expansion coefficients. The results are in good agreement with a finite element approach. (Auth.)

  14. Coupled porohyperelastic mass transport (PHEXPT) finite element models for soft tissues using ABAQUS.

    Science.gov (United States)

    Vande Geest, Jonathan P; Simon, B R; Rigby, Paul H; Newberg, Tyler P

    2011-04-01

    Finite element models (FEMs) including characteristic large deformations in highly nonlinear materials (hyperelasticity and coupled diffusive/convective transport of neutral mobile species) will allow quantitative study of in vivo tissues. Such FEMs will provide basic understanding of normal and pathological tissue responses and lead to optimization of local drug delivery strategies. We present a coupled porohyperelastic mass transport (PHEXPT) finite element approach developed using a commercially available ABAQUS finite element software. The PHEXPT transient simulations are based on sequential solution of the porohyperelastic (PHE) and mass transport (XPT) problems where an Eulerian PHE FEM is coupled to a Lagrangian XPT FEM using a custom-written FORTRAN program. The PHEXPT theoretical background is derived in the context of porous media transport theory and extended to ABAQUS finite element formulations. The essential assumptions needed in order to use ABAQUS are clearly identified in the derivation. Representative benchmark finite element simulations are provided along with analytical solutions (when appropriate). These simulations demonstrate the differences in transient and steady state responses including finite deformations, total stress, fluid pressure, relative fluid, and mobile species flux. A detailed description of important model considerations (e.g., material property functions and jump discontinuities at material interfaces) is also presented in the context of finite deformations. The ABAQUS-based PHEXPT approach enables the use of the available ABAQUS capabilities (interactive FEM mesh generation, finite element libraries, nonlinear material laws, pre- and postprocessing, etc.). PHEXPT FEMs can be used to simulate the transport of a relatively large neutral species (negligible osmotic fluid flux) in highly deformable hydrated soft tissues and tissue-engineered materials.

  15. Finite element analysis of three dimensional crack growth by the use of a boundary element sub model

    DEFF Research Database (Denmark)

    Lucht, Tore

    2009-01-01

    A new automated method to model non-planar three dimensional crack growth is proposed which combines the advantages of both the boundary element method and the finite element method. The proposed method links the two methods by a submodelling strategy in which the solution of a global finite...... element model containing an approximation of the crack is interpolated to a much smaller boundary element model containing a fine discretization of the real crack. The method is validated through several numerical comparisons and by comparison to crack growth measured in a test specimen for an engineering...

  16. Finite element modeling of TFTR poloidal field coils

    International Nuclear Information System (INIS)

    Baumgartner, J.A.; O'Toole, J.A.

    1986-01-01

    The Tokamak Fusion Test Reactor (TFTR) Poloidal Field (PF) coils were originally analyzed to TFTR design conditions. The coils have been reanalyzed by PPPL and Grumman to determine operating limits under as-built conditions. Critical stress levels, based upon data obtained from the reanalysis of each PF coil, are needed for input to the TFTR simulation code algorithms. The primary objective regarding structural integrity has been to ascertain the magnitude and location of critical internal stresses in each PF coil due to various combinations of electromagnetic and thermally induced loads. For each PF coil, a global finite element model (FEM) of a coil sector is being analyzed to obtain the basic coil internal loads and displacements. Subsequent fine mesh local models of the coil lead stem and lead spur regions produce the magnitudes and locations of peak stresses. Each copper turn and its surrounding insulation are modeled using solid finite elements. The corresponding electromagnetic and thermal analyses are similarly modeled. A series of test beams were developed to determine the best combination of MSC/NASTRAN-type finite elements for use in PF coil analysis. The results of this analysis compare favorably with those obtained by the earlier analysis which was limited in scope

  17. A non conforming finite element method for computing eigenmodes of resonant cavities

    International Nuclear Information System (INIS)

    Touze, F.; Le Meur, G.

    1990-06-01

    We present here a non conforming finite element in R 3 . This finite element, built on tetrahedrons, is particularly suited for computing eigenmodes. The main advantage of this element is that it preserves some structural properties of the space in which the solutions of the Maxwell's equations are to be found. Numerical results are presented for both two-dimensional and three-dimensional cases

  18. European column buckling curves and finite element modelling including high strength steels

    DEFF Research Database (Denmark)

    Jönsson, Jeppe; Stan, Tudor-Cristian

    2017-01-01

    Eurocode allows for finite element modelling of plated steel structures, however the information in the code on how to perform the analysis or what assumptions to make is quite sparse. The present paper investigates the deterministic modelling of flexural column buckling using plane shell elements...... imperfections may be very conservative if considered by finite element analysis as described in the current Eurocode code. A suggestion is given for a slightly modified imperfection formula within the Ayrton-Perry formulation leading to adequate inclusion of modern high grade steels within the original four...... bucking curves. It is also suggested that finite element or frame analysis may be performed with equivalent column bow imperfections extracted directly from the Ayrton-Perry formulation....

  19. Hybrid finite element method for describing the electrical response of biological cells to applied fields.

    Science.gov (United States)

    Ying, Wenjun; Henriquez, Craig S

    2007-04-01

    A novel hybrid finite element method (FEM) for modeling the response of passive and active biological membranes to external stimuli is presented. The method is based on the differential equations that describe the conservation of electric flux and membrane currents. By introducing the electric flux through the cell membrane as an additional variable, the algorithm decouples the linear partial differential equation part from the nonlinear ordinary differential equation part that defines the membrane dynamics of interest. This conveniently results in two subproblems: a linear interface problem and a nonlinear initial value problem. The linear interface problem is solved with a hybrid FEM. The initial value problem is integrated by a standard ordinary differential equation solver such as the Euler and Runge-Kutta methods. During time integration, these two subproblems are solved alternatively. The algorithm can be used to model the interaction of stimuli with multiple cells of almost arbitrary geometries and complex ion-channel gating at the plasma membrane. Numerical experiments are presented demonstrating the uses of the method for modeling field stimulation and action potential propagation.

  20. Finite element method - theory and applications

    International Nuclear Information System (INIS)

    Baset, S.

    1992-01-01

    This paper summarizes the mathematical basis of the finite element method. Attention is drawn to the natural development of the method from an engineering analysis tool into a general numerical analysis tool. A particular application to the stress analysis of rubber materials is presented. Special advantages and issues associated with the method are mentioned. (author). 4 refs., 3 figs

  1. Finite groups with three conjugacy class sizes of some elements

    Indian Academy of Sciences (India)

    Conjugacy class sizes; p-nilpotent groups; finite groups. 1. Introduction. All groups ... group G has exactly two conjugacy class sizes of elements of prime power order. .... [5] Huppert B, Character Theory of Finite Groups, de Gruyter Exp. Math.

  2. A least squares principle unifying finite element, finite difference and nodal methods for diffusion theory

    International Nuclear Information System (INIS)

    Ackroyd, R.T.

    1987-01-01

    A least squares principle is described which uses a penalty function treatment of boundary and interface conditions. Appropriate choices of the trial functions and vectors employed in a dual representation of an approximate solution established complementary principles for the diffusion equation. A geometrical interpretation of the principles provides weighted residual methods for diffusion theory, thus establishing a unification of least squares, variational and weighted residual methods. The complementary principles are used with either a trial function for the flux or a trial vector for the current to establish for regular meshes a connection between finite element, finite difference and nodal methods, which can be exact if the mesh pitches are chosen appropriately. Whereas the coefficients in the usual nodal equations have to be determined iteratively, those derived via the complementary principles are given explicitly in terms of the data. For the further development of the connection between finite element, finite difference and nodal methods, some hybrid variational methods are described which employ both a trial function and a trial vector. (author)

  3. A General Symbolic PDE Solver Generator: Explicit Schemes

    Directory of Open Access Journals (Sweden)

    K. Sheshadri

    2003-01-01

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

  4. Dislocation dynamics in non-convex domains using finite elements with embedded discontinuities

    Science.gov (United States)

    Romero, Ignacio; Segurado, Javier; LLorca, Javier

    2008-04-01

    The standard strategy developed by Van der Giessen and Needleman (1995 Modelling Simul. Mater. Sci. Eng. 3 689) to simulate dislocation dynamics in two-dimensional finite domains was modified to account for the effect of dislocations leaving the crystal through a free surface in the case of arbitrary non-convex domains. The new approach incorporates the displacement jumps across the slip segments of the dislocations that have exited the crystal within the finite element analysis carried out to compute the image stresses on the dislocations due to the finite boundaries. This is done in a simple computationally efficient way by embedding the discontinuities in the finite element solution, a strategy often used in the numerical simulation of crack propagation in solids. Two academic examples are presented to validate and demonstrate the extended model and its implementation within a finite element program is detailed in the appendix.

  5. Dislocation dynamics in non-convex domains using finite elements with embedded discontinuities

    International Nuclear Information System (INIS)

    Romero, Ignacio; Segurado, Javier; LLorca, Javier

    2008-01-01

    The standard strategy developed by Van der Giessen and Needleman (1995 Modelling Simul. Mater. Sci. Eng. 3 689) to simulate dislocation dynamics in two-dimensional finite domains was modified to account for the effect of dislocations leaving the crystal through a free surface in the case of arbitrary non-convex domains. The new approach incorporates the displacement jumps across the slip segments of the dislocations that have exited the crystal within the finite element analysis carried out to compute the image stresses on the dislocations due to the finite boundaries. This is done in a simple computationally efficient way by embedding the discontinuities in the finite element solution, a strategy often used in the numerical simulation of crack propagation in solids. Two academic examples are presented to validate and demonstrate the extended model and its implementation within a finite element program is detailed in the appendix

  6. Material model for non-linear finite element analyses of large concrete structures

    NARCIS (Netherlands)

    Engen, Morten; Hendriks, M.A.N.; Øverli, Jan Arve; Åldstedt, Erik; Beushausen, H.

    2016-01-01

    A fully triaxial material model for concrete was implemented in a commercial finite element code. The only required input parameter was the cylinder compressive strength. The material model was suitable for non-linear finite element analyses of large concrete structures. The importance of including

  7. Mathematical aspects of finite element methods for incompressible viscous flows

    Science.gov (United States)

    Gunzburger, M. D.

    1986-01-01

    Mathematical aspects of finite element methods are surveyed for incompressible viscous flows, concentrating on the steady primitive variable formulation. The discretization of a weak formulation of the Navier-Stokes equations are addressed, then the stability condition is considered, the satisfaction of which insures the stability of the approximation. Specific choices of finite element spaces for the velocity and pressure are then discussed. Finally, the connection between different weak formulations and a variety of boundary conditions is explored.

  8. Extension to linear dynamics for hybrid stress finite element formulation based on additional displacements

    Science.gov (United States)

    Sumihara, K.

    Based upon legitimate variational principles, one microscopic-macroscopic finite element formulation for linear dynamics is presented by Hybrid Stress Finite Element Method. The microscopic application of Geometric Perturbation introduced by Pian and the introduction of infinitesimal limit core element (Baby Element) have been consistently combined according to the flexible and inherent interpretation of the legitimate variational principles initially originated by Pian and Tong. The conceptual development based upon Hybrid Finite Element Method is extended to linear dynamics with the introduction of physically meaningful higher modes.

  9. Finite element modelling of aluminum alloy 2024-T3 under transverse impact loading

    Science.gov (United States)

    Abdullah, Ahmad Sufian; Kuntjoro, Wahyu; Yamin, A. F. M.

    2017-12-01

    Fiber metal laminate named GLARE is a new aerospace material which has great potential to be widely used in future lightweight aircraft. It consists of aluminum alloy 2024-T3 and glass-fiber reinforced laminate. In order to produce reliable finite element model of impact response or crashworthiness of structure made of GLARE, one can initially model and validate the finite element model of the impact response of its constituents separately. The objective of this study was to develop a reliable finite element model of aluminum alloy 2024-T3 under low velocity transverse impact loading using commercial software ABAQUS. Johnson-Cook plasticity and damage models were used to predict the alloy's material properties and impact behavior. The results of the finite element analysis were compared to the experiment that has similar material and impact conditions. Results showed good correlations in terms of impact forces, deformation and failure progressions which concluded that the finite element model of 2024-T3 aluminum alloy under low velocity transverse impact condition using Johnson-Cook plastic and damage models was reliable.

  10. An Eulerian-Lagrangian finite-element method for modeling crack growth in creeping materials

    International Nuclear Information System (INIS)

    Lee Hae Sung.

    1991-01-01

    This study is concerned with the development of finite-element-solution methods for analysis of quasi-static, ductile crack growth in history-dependent materials. The mixed Eulerian-Langrangian description (ELD) kinematic model is shown to have several desirable properties for modeling inelastic crack growth. Accordingly, a variational statement based on the ELD for history-dependent materials is developed, and a new moving-grid finite-element method based on the variational statement is presented. The moving-grid finite-element method based on the variational statement is presented. The moving-grid finite-element method is applied to the analysis of transient, quasi-static, mode-III crack growth in creeping materials. A generalized Petrov-Galerkin method (GPG) is developed that simultaneously stabilizes the statement to admit L 2 basis functions for the nonlinear strain field. Quasi-static, model-III crack growth in creeping materials under small-scale-yielding (SSY) conditions is considered. The GPG/ELD moving-grid finite-element formulation is used to model a transient crack-growth problem. The GPG/ELD results compare favorably with previously-published numerical results and the asymptotic solutions

  11. A finite element method for neutron transport

    International Nuclear Information System (INIS)

    Ackroyd, R.T.

    1983-01-01

    A completely boundary-free maximum principle for the first-order Boltzmann equation is derived from the completely boundary-free maximum principle for the mixed-parity Boltzmann equation. When continuity is imposed on the trial function for directions crossing interfaces the completely boundary-free principle for the first-order Boltzmann equation reduces to a maximum principle previously established directly from first principles and indirectly by the Euler-Lagrange method. Present finite element methods for the first-order Boltzmann equation are based on a weighted-residual method which permits the use of discontinuous trial functions. The new principle for the first-order equation can be used as a basis for finite-element methods with the same freedom from boundary conditions as those based on the weighted-residual method. The extremum principle as the parent of the variationally-derived weighted-residual equations ensures their good behaviour. (author)

  12. Isogeometric finite element data structures based on Bézier extraction of T-splines

    NARCIS (Netherlands)

    Scott, M.A.; Borden, M.J.; Verhoosel, C.V.; Sederberg, T.W.; Hughes, T.J.R.

    2011-01-01

    We develop finite element data structures for T-splines based on Bézier extraction generalizing our previous work for NURBS. As in traditional finite element analysis, the extracted Bézier elements are defined in terms of a fixed set of polynomial basis functions, the so-called Bernstein basis. The

  13. Rational bases and generalized barycentrics applications to finite elements and graphics

    CERN Document Server

    Wachspress, Eugene

    2016-01-01

    This three-part volume explores theory for construction of rational interpolation functions for continuous patchwork approximation.  Authored by the namesake of the Wachspress Coordinates, the book develops construction of basis functions for a broad class of elements which have widespread graphics and finite element application. Part one is the 1975 book A Rational Finite Element Basis (with minor updates and corrections) written by Dr. Wachspress.  Part two describes theoretical advances since 1975 and includes analysis of elements not considered previously.  Part three consists of annotated MATLAB programs implementing theory presented in parts one and two.

  14. Development and validation of a magneto-hydrodynamic solver for blood flow analysis

    Energy Technology Data Exchange (ETDEWEB)

    Kainz, W; Guag, J; Krauthamer, V; Myklebust, J; Bassen, H; Chang, I [Center for Devices and Radiological Health, FDA, Silver Spring, MD (United States); Benkler, S; Chavannes, N [Schmid and Partner Engineering AG, Zurich (Switzerland); Szczerba, D; Neufeld, E; Kuster, N [Foundation for Research on Information Technology in Society (IT' IS), Zurich (Switzerland); Kim, J H; Sarntinoranont, M, E-mail: wolfgang.kainz@fda.hhs.go [Soft Tissue Mechanics and Drug Delivery Laboratory, Mechanical and Aerospace Engineering, University of Florida, FL (United States)

    2010-12-07

    The objective of this study was to develop a numerical solver to calculate the magneto-hydrodynamic (MHD) signal produced by a moving conductive liquid, i.e. blood flow in the great vessels of the heart, in a static magnetic field. We believe that this MHD signal is able to non-invasively characterize cardiac blood flow in order to supplement the present non-invasive techniques for the assessment of heart failure conditions. The MHD signal can be recorded on the electrocardiogram (ECG) while the subject is exposed to a strong static magnetic field. The MHD signal can only be measured indirectly as a combination of the heart's electrical signal and the MHD signal. The MHD signal itself is caused by induced electrical currents in the blood due to the moving of the blood in the magnetic field. To characterize and eventually optimize MHD measurements, we developed a MHD solver based on a finite element code. This code was validated against literature, experimental and analytical data. The validation of the MHD solver shows good agreement with all three reference values. Future studies will include the calculation of the MHD signals for anatomical models. We will vary the orientation of the static magnetic field to determine an optimized location for the measurement of the MHD blood flow signal.

  15. Stochastic Finite Element Analysis of Non-Linear Structures Modelled by Plasticity Theory

    DEFF Research Database (Denmark)

    Frier, Christian; Sørensen, John Dalsgaard

    2003-01-01

    A Finite Element Reliability Method (FERM) is introduced to perform reliability analyses on two-dimensional structures in plane stress, modeled by non-linear plasticity theory. FERM is a coupling between the First Order Reliability Method (FORM) and the Finite Element Method (FEM). FERM can be us...

  16. Multilayer Finite-Element Model Application to Define the Bearing Structure Element Stress State of Launch Complexes

    Directory of Open Access Journals (Sweden)

    V. A. Zverev

    2016-01-01

    Full Text Available The article objective is to justify the rationale for selecting the multilayer finite element model parameters of the bearing structure of a general-purpose launch complex unit.A typical design element of the launch complex unit, i.e. a mount of the hydraulic or pneumatic cylinder, block, etc. is under consideration. The mount represents a set of the cantilevered axis and external structural cage. The most loaded element of the cage is disk to which a moment is transferred from the cantilevered axis due to actuator effort acting on it.To calculate the stress-strain state of disk was used a finite element method. Five models of disk mount were created. The only difference in models was the number of layers of the finite elements through the thickness of disk. There were models, which had one, three, five, eight, and fourteen layers of finite elements through the thickness of disk. For each model, we calculated the equivalent stresses arising from the action of the test load. Disk models were formed and calculated using the MSC Nastran complex software.The article presents results in the table to show data of equivalent stresses in each of the multi-layered models and graphically to illustrate the changing equivalent stresses through the thickness of disk.Based on these results we have given advice on selecting the proper number of layers in the model allowing a desirable accuracy of results with the lowest run time. In addition, it is concluded that there is a need to use the multi-layer models in assessing the performance of structural elements in case the stress exceeds the allowable one in their surface layers.

  17. OpenSeesPy: Python library for the OpenSees finite element framework

    Science.gov (United States)

    Zhu, Minjie; McKenna, Frank; Scott, Michael H.

    2018-01-01

    OpenSees, an open source finite element software framework, has been used broadly in the earthquake engineering community for simulating the seismic response of structural and geotechnical systems. The framework allows users to perform finite element analysis with a scripting language and for developers to create both serial and parallel finite element computer applications as interpreters. For the last 15 years, Tcl has been the primary scripting language to which the model building and analysis modules of OpenSees are linked. To provide users with different scripting language options, particularly Python, the OpenSees interpreter interface was refactored to provide multi-interpreter capabilities. This refactoring, resulting in the creation of OpenSeesPy as a Python module, is accomplished through an abstract interface for interpreter calls with concrete implementations for different scripting languages. Through this approach, users are able to develop applications that utilize the unique features of several scripting languages while taking advantage of advanced finite element analysis models and algorithms.

  18. Transport and dispersion of pollutants in surface impoundments: a finite element model

    International Nuclear Information System (INIS)

    Yeh, G.T.

    1980-07-01

    A surface impoundment model in finite element (SIMFE) is presented to enable the simulation of flow circulations and pollutant transport and dispersion in natural or artificial lakes, reservoirs or ponds with any number of islands. This surface impoundment model consists of two sub-models: hydrodynamic and pollutant transport models. Both submodels are simulated by the finite element method. While the hydrodynamic model is solved by the standard Galerkin finite element scheme, the pollutant transport model can be solved by any of the twelve optional finite element schemes built in the program. Theoretical approximations and the numerical algorithm of SIMFE are described. Detail instruction of the application are given and listing of FORTRAN IV source program are provided. Two sample problems are given. One is for an idealized system with a known solution to show the accuracy and partial validation of the models. The other is applied to Prairie Island for a set of hypothetical input data, typifying a class of problems to which SIMFE may be applied

  19. Numerical simulation of mechatronic sensors and actuators finite elements for computational multiphysics

    CERN Document Server

    Kaltenbacher, Manfred

    2015-01-01

    Like the previous editions also the third edition of this book combines the detailed physical modeling of mechatronic systems and their precise numerical simulation using the Finite Element (FE) method. Thereby, the basic chapter concerning the Finite Element (FE) method is enhanced, provides now also a description of higher order finite elements (both for nodal and edge finite elements) and a detailed discussion of non-conforming mesh techniques. The author enhances and improves many discussions on principles and methods. In particular, more emphasis is put on the description of single fields by adding the flow field. Corresponding to these field, the book is augmented with the new chapter about coupled flow-structural mechanical systems. Thereby, the discussion of computational aeroacoustics is extended towards perturbation approaches, which allows a decomposition of flow and acoustic quantities within the flow region. Last but not least, applications are updated and restructured so that the book meets mode...

  20. Transport and dispersion of pollutants in surface impoundments: a finite element model

    Energy Technology Data Exchange (ETDEWEB)

    Yeh, G.T.

    1980-07-01

    A surface impoundment model in finite element (SIMFE) is presented to enable the simulation of flow circulations and pollutant transport and dispersion in natural or artificial lakes, reservoirs or ponds with any number of islands. This surface impoundment model consists of two sub-models: hydrodynamic and pollutant transport models. Both submodels are simulated by the finite element method. While the hydrodynamic model is solved by the standard Galerkin finite element scheme, the pollutant transport model can be solved by any of the twelve optional finite element schemes built in the program. Theoretical approximations and the numerical algorithm of SIMFE are described. Detail instruction of the application are given and listing of FORTRAN IV source program are provided. Two sample problems are given. One is for an idealized system with a known solution to show the accuracy and partial validation of the models. The other is applied to Prairie Island for a set of hypothetical input data, typifying a class of problems to which SIMFE may be applied.

  1. [Research Progress and Prospect of Applications of Finite Element Method in Lumbar Spine Biomechanics].

    Science.gov (United States)

    Zhang, Zhenjun; Li, Yang; Liao, Zhenhua; Liu, Weiqiang

    2016-12-01

    Based on the application of finite element analysis in spine biomechanics,the research progress of finite element method applied in lumbar spine mechanics is reviewed and the prospect is forecasted.The related works,including lumbar ontology modeling,clinical application research,and occupational injury and protection,are summarized.The main research areas of finite element method are as follows:new accurate modeling process,the optimized simulation method,diversified clinical effect evaluation,and the clinical application of artificial lumbar disc.According to the recent research progress,the application prospects of finite element method,such as automation and individuation of modeling process,evaluation and analysis of new operation methods and simulation of mechanical damage and dynamic response,are discussed.The purpose of this paper is to provide the theoretical reference and practical guidance for the clinical lumbar problems by reviewing the application of finite element method in the field of the lumbar spine biomechanics.

  2. Finite element analyses for RF photoinjector gun cavities

    International Nuclear Information System (INIS)

    Marhauser, F.

    2006-01-01

    This paper details electromagnetical, thermal and structural 3D Finite Element Analyses (FEA) for normal conducting RF photoinjector gun cavities. The simulation methods are described extensively. Achieved results are presented. (orig.)

  3. Finite element analyses for RF photoinjector gun cavities

    Energy Technology Data Exchange (ETDEWEB)

    Marhauser, F. [Berliner Elektronenspeicherring-Gesellschaft fuer Synchrotronstrahlung mbH (BESSY), Berlin (Germany)

    2006-07-01

    This paper details electromagnetical, thermal and structural 3D Finite Element Analyses (FEA) for normal conducting RF photoinjector gun cavities. The simulation methods are described extensively. Achieved results are presented. (orig.)

  4. Validation Assessment of a Glass-to-Metal Seal Finite-Element Model

    Energy Technology Data Exchange (ETDEWEB)

    Jamison, Ryan Dale [Sandia National Lab. (SNL-NM), Albuquerque, NM (United States); Buchheit, Thomas E. [Sandia National Lab. (SNL-NM), Albuquerque, NM (United States); Emery, John M [Sandia National Lab. (SNL-NM), Albuquerque, NM (United States); Romero, Vicente J. [Sandia National Lab. (SNL-NM), Albuquerque, NM (United States); Stavig, Mark E. [Sandia National Lab. (SNL-NM), Albuquerque, NM (United States); Newton, Clay S. [Sandia National Lab. (SNL-NM), Albuquerque, NM (United States); Brown, Arthur [Sandia National Lab. (SNL-NM), Albuquerque, NM (United States)

    2017-10-01

    Sealing glasses are ubiquitous in high pressure and temperature engineering applications, such as hermetic feed-through electrical connectors. A common connector technology are glass-to-metal seals where a metal shell compresses a sealing glass to create a hermetic seal. Though finite-element analysis has been used to understand and design glass-to-metal seals for many years, there has been little validation of these models. An indentation technique was employed to measure the residual stress on the surface of a simple glass-to-metal seal. Recently developed rate- dependent material models of both Schott 8061 and 304L VAR stainless steel have been applied to a finite-element model of the simple glass-to-metal seal. Model predictions of residual stress based on the evolution of material models are shown. These model predictions are compared to measured data. Validity of the finite- element predictions is discussed. It will be shown that the finite-element model of the glass-to-metal seal accurately predicts the mean residual stress in the glass near the glass-to-metal interface and is valid for this quantity of interest.

  5. A cohesive finite element formulation for modelling fracture and ...

    Indian Academy of Sciences (India)

    cohesive elements experience material softening and lose their stress carrying capacity. A few simple ..... In the present work, a Lagrangian finite element procedure is employed. In this formu clation ...... o, is related to 'c o by,. 't o='c o ¼ 1 ہ. 1.

  6. Some aspects of the quality assurance of personnel carrying out finite element analysis

    International Nuclear Information System (INIS)

    Dickenson, P.W.

    1990-01-01

    In this paper, the need to assess the competence of personnel carrying out finite element analysis is emphasised. In carrying out its regulatory role on behalf of the Health and Safety Executive, the Nuclear Installations Inspectorate (NII) must be satisfied that appropriate standards are developed and maintained by the licensee. Since finite element methods have an important bearing on the acceptance of a safety case, it follows that relevant codes should be adequately validated and the personnel applying the code should be competent. Attention is drawn to the work of the Quality Assurance Working Group of the National Agency for Finite Element Methods and Standards (NAFEMS) who are active in this area. The paper also considers the methods that are available to assess the competence of personnel engaged in finite element methods. (author)

  7. Comparative study of incompressible and isothermal compressible flow solvers for cavitating flow dynamics

    Energy Technology Data Exchange (ETDEWEB)

    Park, Sun Ho [Korea Maritime and Ocean University, Busan (Korea, Republic of); Rhee, Shin Hyung [Seoul National University, Seoul (Korea, Republic of)

    2015-08-15

    Incompressible flow solvers are generally used for numerical analysis of cavitating flows, but with limitations in handling compressibility effects on vapor phase. To study compressibility effects on vapor phase and cavity interface, pressure-based incompressible and isothermal compressible flow solvers based on a cell-centered finite volume method were developed using the OpenFOAM libraries. To validate the solvers, cavitating flow around a hemispherical head-form body was simulated and validated against the experimental data. The cavity shedding behavior, length of a re-entrant jet, drag history, and the Strouhal number were compared between the two solvers. The results confirmed that computations of the cavitating flow including compressibility effects improved the reproduction of cavitation dynamics.

  8. Advances in dynamic relaxation techniques for nonlinear finite element analysis

    International Nuclear Information System (INIS)

    Sauve, R.G.; Metzger, D.R.

    1995-01-01

    Traditionally, the finite element technique has been applied to static and steady-state problems using implicit methods. When nonlinearities exist, equilibrium iterations must be performed using Newton-Raphson or quasi-Newton techniques at each load level. In the presence of complex geometry, nonlinear material behavior, and large relative sliding of material interfaces, solutions using implicit methods often become intractable. A dynamic relaxation algorithm is developed for inclusion in finite element codes. The explicit nature of the method avoids large computer memory requirements and makes possible the solution of large-scale problems. The method described approaches the steady-state solution with no overshoot, a problem which has plagued researchers in the past. The method is included in a general nonlinear finite element code. A description of the method along with a number of new applications involving geometric and material nonlinearities are presented. They include: (1) nonlinear geometric cantilever plate; (2) moment-loaded nonlinear beam; and (3) creep of nuclear fuel channel assemblies

  9. Modelling of Conveyor Belt Passage by Driving Drum Using Finite Element Methods

    Directory of Open Access Journals (Sweden)

    Nikoleta Mikušová

    2017-12-01

    Full Text Available The finite element methods are used in many disciplines by the development of products, typically in mechanical engineering (for example in automotive industry, biomechanics, etc.. Some modern programs of the finite element's methods have specific tools (electromagnetic, fluid and structural simulations. The finite elements methods allow detailed presentation of structures by bending or torsion, complete design, testing and optimization before the prototype production. The aims of this paper were to the model of conveyor belt passage by driving drum. The model was created by the program Abaqus CAE. The created model presented data about forces, pressures, and deformation of the belt conveyor.

  10. Finite-element pre-analysis for pressurized thermoshock tests

    International Nuclear Information System (INIS)

    Keinaenen, H.; Talja, H.; Lehtonen, M.; Rintamaa, R.; Bljumin, A.; Timofeev, B.

    1992-05-01

    The behaviour of a model pressure vessel is studied in a pressurized thermal shock loading. The tests were performed at the Prometey Institute in St. Petersburg. The calculations were performed at the Technical Research Centre of Finland. The report describes the preliminary finite-element analyses for the fourth, fifth and sixth thermoshock tests with the first model pressure vessel. Seven pressurized thermoshock tests were made with the same model using five different flaw geometries. In the first three tests the flaw was actually a blunt notch. In the two following tests (tests 4 and 5) a sharp pre-crack was produced before the test. In the last two test (tests 6 and 7) the old crack was used. According to the measurements and post-test ultrasonic examination of the crack front, the sixth test led to significant crack extension. Both temperatures and stresses were calculated using the finite-element method. The calculations were made using the idealized initial flaw geometry and preliminary material data. Both two-and three-dimensional models were used in the calculations. J-integral values were calculated from the elastic-plastic finite-element results. The stress intensity factor values were evaluated on the basis of the calculated J-integrals and compared with the preliminary material fracture toughness data obtained from the Prometey Institute

  11. Finite element analysis of FRP-strengthened RC beams

    Directory of Open Access Journals (Sweden)

    Teeraphot Supaviriyakit

    2004-05-01

    Full Text Available This paper presents a non-linear finite element analysis of reinforced concrete beam strengthened with externally bonded FRP plates. The finite element modeling of FRP-strengthened beams is demonstrated. Concrete and reinforcing bars are modeled together as 8-node isoparametric 2D RC element. The FRP plate is modeled as 8-node isoparametric 2D elastic element. The glue is modeled as perfect compatibility by directly connecting the nodes of FRP with those of concrete since there is no failure at the glue layer. The key to the analysis is the correct material models of concrete, steel and FRP. Cracks and steel bars are modeled as smeared over the entire element. Stress-strain properties of cracked concrete consist of tensile stress model normal to crack, compressive stress model parallel to crack and shear stress model tangential to crack. Stressstrain property of reinforcement is assumed to be elastic-hardening to account for the bond between concrete and steel bars. FRP is modeled as elastic-brittle material. From the analysis, it is found that FEM can predict the load-displacement relation, ultimate load and failure mode of the beam correctly. It can also capture the cracking process for both shear-flexural peeling and end peeling modes similar to the experiment.

  12. Finite Element Method Based Modeling of Resistance Spot-Welded Mild Steel

    Directory of Open Access Journals (Sweden)

    Miloud Zaoui

    Full Text Available Abstract This paper deals with Finite Element refined and simplified models of a mild steel spot-welded specimen, developed and validated based on quasi-static cross-tensile experimental tests. The first model was constructed with a fine discretization of the metal sheet and the spot weld was defined as a special geometric zone of the specimen. This model provided, in combination with experimental tests, the input data for the development of the second model, which was constructed with respect to the mesh size used in the complete car finite element model. This simplified model was developed with coarse shell elements and a spring-type beam element was used to model the spot weld behavior. The global accuracy of the two models was checked by comparing simulated and experimental load-displacement curves and by studying the specimen deformed shapes and the plastic deformation growth in the metal sheets. The obtained results show that both fine and coarse finite element models permit a good prediction of the experimental tests.

  13. Image segmentation with a finite element method

    DEFF Research Database (Denmark)

    Bourdin, Blaise

    1999-01-01

    regularization results, make possible to imagine a finite element resolution method.In a first time, the Mumford-Shah functional is introduced and some existing results are quoted. Then, a discrete formulation for the Mumford-Shah problem is proposed and its $\\Gamma$-convergence is proved. Finally, some...

  14. Investigations on Actuator Dynamics through Theoretical and Finite Element Approach

    Directory of Open Access Journals (Sweden)

    Somashekhar S. Hiremath

    2010-01-01

    Full Text Available This paper gives a new approach for modeling the fluid-structure interaction of servovalve component-actuator. The analyzed valve is a precision flow control valve-jet pipe electrohydraulic servovalve. The positioning of an actuator depends upon the flow rate from control ports, in turn depends on the spool position. Theoretical investigation is made for No-load condition and Load condition for an actuator. These are used in finite element modeling of an actuator. The fluid-structure-interaction (FSI is established between the piston and the fluid cavities at the piston end. The fluid cavities were modeled with special purpose hydrostatic fluid elements while the piston is modeled with brick elements. The finite element method is used to simulate the variation of cavity pressure, cavity volume, mass flow rate, and the actuator velocity. The finite element analysis is extended to study the system's linearized response to harmonic excitation using direct solution steady-state dynamics. It was observed from the analysis that the natural frequency of the actuator depends upon the position of the piston in the cylinder. This is a close match with theoretical and simulation results. The effect of bulk modulus is also presented in the paper.

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

  16. Three-dimensional forward solver and its performance analysis for magnetic resonance electrical impedance tomography (MREIT) using recessed electrodes

    International Nuclear Information System (INIS)

    Lee, Byung Il; Oh, Suk Hoon; Woo, Eung Je; Lee, Soo Yeol; Cho, Min Hyoung; Kwon, Ohin; Seo, Jin Keun; Lee, June-Yub; Baek, Woon Sik

    2003-01-01

    In magnetic resonance electrical impedance tomography (MREIT), we try to reconstruct a cross-sectional resistivity (or conductivity) image of a subject. When we inject a current through surface electrodes, it generates a magnetic field. Using a magnetic resonance imaging (MRI) scanner, we can obtain the induced magnetic flux density from MR phase images of the subject. We use recessed electrodes to avoid undesirable artefacts near electrodes in measuring magnetic flux densities. An MREIT image reconstruction algorithm produces cross-sectional resistivity images utilizing the measured internal magnetic flux density in addition to boundary voltage data. In order to develop such an image reconstruction algorithm, we need a three-dimensional forward solver. Given injection currents as boundary conditions, the forward solver described in this paper computes voltage and current density distributions using the finite element method (FEM). Then, it calculates the magnetic flux density within the subject using the Biot-Savart law and FEM. The performance of the forward solver is analysed and found to be enough for use in MREIT for resistivity image reconstructions and also experimental designs and validations. The forward solver may find other applications where one needs to compute voltage, current density and magnetic flux density distributions all within a volume conductor

  17. Multiscale Simulations for Coupled Flow and Transport Using the Generalized Multiscale Finite Element Method

    KAUST Repository

    Chung, Eric; Efendiev, Yalchin R.; Leung, Wing; Ren, Jun

    2015-01-01

    In this paper, we develop a mass conservative multiscale method for coupled flow and transport in heterogeneous porous media. We consider a coupled system consisting of a convection-dominated transport equation and a flow equation. We construct a coarse grid solver based on the Generalized Multiscale Finite Element Method (GMsFEM) for a coupled system. In particular, multiscale basis functions are constructed based on some snapshot spaces for the pressure and the concentration equations and some local spectral decompositions in the snapshot spaces. The resulting approach uses a few multiscale basis functions in each coarse block (for both the pressure and the concentration) to solve the coupled system. We use the mixed framework, which allows mass conservation. Our main contributions are: (1) the development of a mass conservative GMsFEM for the coupled flow and transport; (2) the development of a robust multiscale method for convection-dominated transport problems by choosing appropriate test and trial spaces within Petrov-Galerkin mixed formulation. We present numerical results and consider several heterogeneous permeability fields. Our numerical results show that with only a few basis functions per coarse block, we can achieve a good approximation.

  18. Multiscale Simulations for Coupled Flow and Transport Using the Generalized Multiscale Finite Element Method

    KAUST Repository

    Chung, Eric

    2015-12-11

    In this paper, we develop a mass conservative multiscale method for coupled flow and transport in heterogeneous porous media. We consider a coupled system consisting of a convection-dominated transport equation and a flow equation. We construct a coarse grid solver based on the Generalized Multiscale Finite Element Method (GMsFEM) for a coupled system. In particular, multiscale basis functions are constructed based on some snapshot spaces for the pressure and the concentration equations and some local spectral decompositions in the snapshot spaces. The resulting approach uses a few multiscale basis functions in each coarse block (for both the pressure and the concentration) to solve the coupled system. We use the mixed framework, which allows mass conservation. Our main contributions are: (1) the development of a mass conservative GMsFEM for the coupled flow and transport; (2) the development of a robust multiscale method for convection-dominated transport problems by choosing appropriate test and trial spaces within Petrov-Galerkin mixed formulation. We present numerical results and consider several heterogeneous permeability fields. Our numerical results show that with only a few basis functions per coarse block, we can achieve a good approximation.

  19. Finite element modeling of trolling-mode AFM.

    Science.gov (United States)

    Sajjadi, Mohammadreza; Pishkenari, Hossein Nejat; Vossoughi, Gholamreza

    2018-06-01

    Trolling mode atomic force microscopy (TR-AFM) has overcome many imaging problems in liquid environments by considerably reducing the liquid-resonator interaction forces. The finite element model of the TR-AFM resonator considering the effects of fluid and nanoneedle flexibility is presented in this research, for the first time. The model is verified by ABAQUS software. The effect of installation angle of the microbeam relative to the horizon and the effect of fluid on the system behavior are investigated. Using the finite element model, frequency response curve of the system is obtained and validated around the frequency of the operating mode by the available experimental results, in air and liquid. The changes in the natural frequencies in the presence of liquid are studied. The effects of tip-sample interaction on the excitation of higher order modes of the system are also investigated in air and liquid environments. Copyright © 2018 Elsevier B.V. All rights reserved.

  20. Finite element simulations with ANSYS workbench 16

    CERN Document Server

    Lee , Huei-Huang

    2015-01-01

    Finite Element Simulations with ANSYS Workbench 16 is a comprehensive and easy to understand workbook. It utilizes step-by-step instructions to help guide readers to learn finite element simulations. Twenty seven real world case studies are used throughout the book. Many of these cases are industrial or research projects the reader builds from scratch. All the files readers may need if they have trouble are available for download on the publishers website. Companion videos that demonstrate exactly how to preform each tutorial are available to readers by redeeming the access code that comes in the book. Relevant background knowledge is reviewed whenever necessary. To be efficient, the review is conceptual rather than mathematical. Key concepts are inserted whenever appropriate and summarized at the end of each chapter. Additional exercises or extension research problems are provided as homework at the end of each chapter. A learning approach emphasizing hands-on experiences spreads through this entire book. A...

  1. Algorithms and data structures for massively parallel generic adaptive finite element codes

    KAUST Repository

    Bangerth, Wolfgang

    2011-12-01

    Today\\'s largest supercomputers have 100,000s of processor cores and offer the potential to solve partial differential equations discretized by billions of unknowns. However, the complexity of scaling to such large machines and problem sizes has so far prevented the emergence of generic software libraries that support such computations, although these would lower the threshold of entry and enable many more applications to benefit from large-scale computing. We are concerned with providing this functionality for mesh-adaptive finite element computations. We assume the existence of an "oracle" that implements the generation and modification of an adaptive mesh distributed across many processors, and that responds to queries about its structure. Based on querying the oracle, we develop scalable algorithms and data structures for generic finite element methods. Specifically, we consider the parallel distribution of mesh data, global enumeration of degrees of freedom, constraints, and postprocessing. Our algorithms remove the bottlenecks that typically limit large-scale adaptive finite element analyses. We demonstrate scalability of complete finite element workflows on up to 16,384 processors. An implementation of the proposed algorithms, based on the open source software p4est as mesh oracle, is provided under an open source license through the widely used deal.II finite element software library. © 2011 ACM 0098-3500/2011/12-ART10 $10.00.

  2. Discrete maximum principle for the P1 - P0 weak Galerkin finite element approximations

    Science.gov (United States)

    Wang, Junping; Ye, Xiu; Zhai, Qilong; Zhang, Ran

    2018-06-01

    This paper presents two discrete maximum principles (DMP) for the numerical solution of second order elliptic equations arising from the weak Galerkin finite element method. The results are established by assuming an h-acute angle condition for the underlying finite element triangulations. The mathematical theory is based on the well-known De Giorgi technique adapted in the finite element context. Some numerical results are reported to validate the theory of DMP.

  3. The Spectral/hp-Finite Element Method for Partial Differential Equations

    DEFF Research Database (Denmark)

    Engsig-Karup, Allan Peter

    2009-01-01

    dimensions. In the course the chosen programming environment is Matlab, however, this is by no means a necessary requirement. The mathematical level needed to grasp the details of this set of notes requires an elementary background in mathematical analysis and linear algebra. Each chapter is supplemented......This set of lecture notes provides an elementary introduction to both the classical Finite Element Method (FEM) and the extended Spectral/$hp$-Finite Element Method for solving Partial Differential Equations (PDEs). Many problems in science and engineering can be formulated mathematically...

  4. Application of the finite element method to the neutron transport equation

    International Nuclear Information System (INIS)

    Martin, W.R.

    1976-01-01

    This paper examines the theoretical and practical application of the finite element method to the neutron transport equation. It is shown that in principle the system of equations obtained by application of the finite element method can be solved with certain physical restrictions concerning the criticality of the medium. The convergence of this approximate solution to the exact solution with mesh refinement is examined, and a non-optical estimate of the convergence rate is obtained analytically. It is noted that the numerical results indicate a faster convergence rate and several approaches to obtain this result analytically are outlined. The practical application of the finite element method involved the development of a computer code capable of solving the neutron transport equation in 1-D plane geometry. Vacuum, reflecting, or specified incoming boundary conditions may be analyzed, and all are treated as natural boundary conditions. The time-dependent transport equation is also examined and it is shown that the application of the finite element method in conjunction with the Crank-Nicholson time discretization method results in a system of algebraic equations which is readily solved. Numerical results are given for several critical slab eigenvalue problems, including anisotropic scattering, and the results compare extremely well with benchmark results. It is seen that the finite element code is more efficient than a standard discrete ordinates code for certain problems. A problem with severe heterogeneities is considered and it is shown that the use of discontinuous spatial and angular elements results in a marked improvement in the results. Finally, time-dependent problems are examined and it is seen that the phenomenon of angular mode separation makes the numerical treatment of the transport equation in slab geometry a considerable challenge, with the result that the angular mesh has a dominant effect on obtaining acceptable solutions

  5. Stability Analysis of Anchored Soil Slope Based on Finite Element Limit Equilibrium Method

    Directory of Open Access Journals (Sweden)

    Rui Zhang

    2016-01-01

    Full Text Available Under the condition of the plane strain, finite element limit equilibrium method is used to study some key problems of stability analysis for anchored slope. The definition of safe factor in slices method is generalized into FEM. The “true” stress field in the whole structure can be obtained by elastic-plastic finite element analysis. Then, the optimal search for the most dangerous sliding surface with Hooke-Jeeves optimized searching method is introduced. Three cases of stability analysis of natural slope, anchored slope with seepage, and excavation anchored slope are conducted. The differences in safety factor quantity, shape and location of slip surface, anchoring effect among slices method, finite element strength reduction method (SRM, and finite element limit equilibrium method are comparatively analyzed. The results show that the safety factor given by the FEM is greater and the unfavorable slip surface is deeper than that by the slice method. The finite element limit equilibrium method has high calculation accuracy, and to some extent the slice method underestimates the effect of anchor, and the effect of anchor is overrated in the SRM.

  6. FINITE ELEMENT MODELING OF THIN CIRCULAR SANDWICH PLATES DEFLECTION

    Directory of Open Access Journals (Sweden)

    K. S. Kurachka

    2014-01-01

    Full Text Available A mathematical model of a thin circular sandwich plate being under the vertical load is proposed. The model employs the finite element method and takes advantage of an axisymmetric finite element that leads to the small dimension of the resulting stiffness matrix and sufficient accuracy for practical calculations. The analytical expressions for computing local stiffness matrices are found, which can significantly speed up the process of forming the global stiffness matrix and increase the accuracy of calculations. A software is under development and verification. The discrepancy between the results of the mathematical model and those of analytical formulas for homogeneous thin circularsandwich plates does not exceed 7%.

  7. A finite element model of ferroelectric/ferroelastic polycrystals

    Energy Technology Data Exchange (ETDEWEB)

    HWANG,STEPHEN C.; MCMEEKING,ROBERT M.

    2000-02-17

    A finite element model of polarization switching in a polycrystalline ferroelectric/ferroelastic ceramic is developed. It is assumed that a crystallite switches if the reduction in potential energy of the polycrystal exceeds a critical energy barrier per unit volume of switching material. Each crystallite is represented by a finite element with the possible dipole directions assigned randomly subject to crystallographic constraints. The model accounts for both electric field induced (i.e. ferroelectric) switching and stress induced (i.e. ferroelastic) switching with piezoelectric interactions. Experimentally measured elastic, dielectric, and piezoelectric constants are used consistently, but different effective critical energy barriers are selected phenomenologically. Electric displacement versus electric field, strain versus electric field, stress versus strain, and stress versus electric displacement loops of a ceramic lead lanthanum zirconate titanate (PLZT) are modeled well below the Curie temperature.

  8. Finite Element Method for Analysis of Material Properties

    DEFF Research Database (Denmark)

    Rauhe, Jens Christian

    and the finite element method. The material microstructure of the heterogeneous material is non-destructively determined using X-ray microtomography. A software program has been generated which uses the X-ray tomographic data as an input for the mesh generation of the material microstructure. To obtain a proper...... which are used for the determination of the effective properties of the heterogeneous material. Generally, the properties determined using the finite element method coupled with X-ray microtomography are in good agreement with both experimentally determined properties and properties determined using......The use of cellular and composite materials have in recent years become more and more common in all kinds of structural components and accurate knowledge of the effective properties is therefore essential. In this wok the effective properties are determined using the real material microstructure...

  9. A Finite Element Model for convection-dominatel transport problems

    International Nuclear Information System (INIS)

    Carmo, E.G.D. do; Galeao, A.C.N.R.

    1987-08-01

    A new Protev-Galerkin Finite Element Model which automatically incorporates the search for the appropriate upwind direction is presented. It is also shown that modifying the Petrov-Galerkin weightin functions associated with elements adjascent to downwing boudaries effectively eliminates numerical oscillations normally obtained near boundary layers. (Author) [pt

  10. Modelling Convergence of Finite Element Analysis of Cantilever Beam

    African Journals Online (AJOL)

    Convergence studies are carried out by investigating the convergence of numerical results as the number of elements is increased. If convergence is not obtained, the engineer using the finite element method has absolutely no indication whether the results are indicative of a meaningful approximation to the correct solution ...

  11. Finite element modeling of nanotube structures linear and non-linear models

    CERN Document Server

    Awang, Mokhtar; Muhammad, Ibrahim Dauda

    2016-01-01

    This book presents a new approach to modeling carbon structures such as graphene and carbon nanotubes using finite element methods, and addresses the latest advances in numerical studies for these materials. Based on the available findings, the book develops an effective finite element approach for modeling the structure and the deformation of grapheme-based materials. Further, modeling processing for single-walled and multi-walled carbon nanotubes is demonstrated in detail.

  12. Investigation of the Behavior of Steel Shear Walls Using Finite Elements Analysis

    OpenAIRE

    Abubakri, K.; Veladi, H.

    2016-01-01

    Currently, steel shear walls are considered by engineers as an economic method against lateral loads imposed by wind and earthquake in tall structures. Accordingly, there is a growing need to develop accurate methods alongside approximation methods to estimate the behavior of these structural elements. The finite element technique is one of the strongest numerical methods in analysis of solid mechanics problems. Finite element analysis however requires high technical knowledge of the behavior...

  13. Finite element modelling

    International Nuclear Information System (INIS)

    Tonks, M.R.; Williamson, R.; Masson, R.

    2015-01-01

    The Finite Element Method (FEM) is a numerical technique for finding approximate solutions to boundary value problems. While FEM is commonly used to solve solid mechanics equations, it can be applied to a large range of BVPs from many different fields. FEM has been used for reactor fuels modelling for many years. It is most often used for fuel performance modelling at the pellet and pin scale, however, it has also been used to investigate properties of the fuel material, such as thermal conductivity and fission gas release. Recently, the United Stated Department Nuclear Energy Advanced Modelling and Simulation Program has begun using FEM as the basis of the MOOSE-BISON-MARMOT Project that is developing a multi-dimensional, multi-physics fuel performance capability that is massively parallel and will use multi-scale material models to provide a truly predictive modelling capability. (authors)

  14. Steam generator tube rupture simulation using extended finite element method

    Energy Technology Data Exchange (ETDEWEB)

    Mohanty, Subhasish, E-mail: smohanty@anl.gov; Majumdar, Saurin; Natesan, Ken

    2016-08-15

    Highlights: • Extended finite element method used for modeling the steam generator tube rupture. • Crack propagation is modeled in an arbitrary solution dependent path. • The FE model is used for estimating the rupture pressure of steam generator tubes. • Crack coalescence modeling is also demonstrated. • The method can be used for crack modeling of tubes under severe accident condition. - Abstract: A steam generator (SG) is an important component of any pressurized water reactor. Steam generator tubes represent a primary pressure boundary whose integrity is vital to the safe operation of the reactor. SG tubes may rupture due to propagation of a crack created by mechanisms such as stress corrosion cracking, fatigue, etc. It is thus important to estimate the rupture pressures of cracked tubes for structural integrity evaluation of SGs. The objective of the present paper is to demonstrate the use of extended finite element method capability of commercially available ABAQUS software, to model SG tubes with preexisting flaws and to estimate their rupture pressures. For the purpose, elastic–plastic finite element models were developed for different SG tubes made from Alloy 600 material. The simulation results were compared with experimental results available from the steam generator tube integrity program (SGTIP) sponsored by the United States Nuclear Regulatory Commission (NRC) and conducted at Argonne National Laboratory (ANL). A reasonable correlation was found between extended finite element model results and experimental results.

  15. Steam generator tube rupture simulation using extended finite element method

    International Nuclear Information System (INIS)

    Mohanty, Subhasish; Majumdar, Saurin; Natesan, Ken

    2016-01-01

    Highlights: • Extended finite element method used for modeling the steam generator tube rupture. • Crack propagation is modeled in an arbitrary solution dependent path. • The FE model is used for estimating the rupture pressure of steam generator tubes. • Crack coalescence modeling is also demonstrated. • The method can be used for crack modeling of tubes under severe accident condition. - Abstract: A steam generator (SG) is an important component of any pressurized water reactor. Steam generator tubes represent a primary pressure boundary whose integrity is vital to the safe operation of the reactor. SG tubes may rupture due to propagation of a crack created by mechanisms such as stress corrosion cracking, fatigue, etc. It is thus important to estimate the rupture pressures of cracked tubes for structural integrity evaluation of SGs. The objective of the present paper is to demonstrate the use of extended finite element method capability of commercially available ABAQUS software, to model SG tubes with preexisting flaws and to estimate their rupture pressures. For the purpose, elastic–plastic finite element models were developed for different SG tubes made from Alloy 600 material. The simulation results were compared with experimental results available from the steam generator tube integrity program (SGTIP) sponsored by the United States Nuclear Regulatory Commission (NRC) and conducted at Argonne National Laboratory (ANL). A reasonable correlation was found between extended finite element model results and experimental results.

  16. A collocation--Galerkin finite element model of cardiac action potential propagation.

    Science.gov (United States)

    Rogers, J M; McCulloch, A D

    1994-08-01

    A new computational method was developed for modeling the effects of the geometric complexity, nonuniform muscle fiber orientation, and material inhomogeneity of the ventricular wall on cardiac impulse propagation. The method was used to solve a modification to the FitzHugh-Nagumo system of equations. The geometry, local muscle fiber orientation, and material parameters of the domain were defined using linear Lagrange or cubic Hermite finite element interpolation. Spatial variations of time-dependent excitation and recovery variables were approximated using cubic Hermite finite element interpolation, and the governing finite element equations were assembled using the collocation method. To overcome the deficiencies of conventional collocation methods on irregular domains, Galerkin equations for the no-flux boundary conditions were used instead of collocation equations for the boundary degrees-of-freedom. The resulting system was evolved using an adaptive Runge-Kutta method. Converged two-dimensional simulations of normal propagation showed that this method requires less CPU time than a traditional finite difference discretization. The model also reproduced several other physiologic phenomena known to be important in arrhythmogenesis including: Wenckebach periodicity, slowed propagation and unidirectional block due to wavefront curvature, reentry around a fixed obstacle, and spiral wave reentry. In a new result, we observed wavespeed variations and block due to nonuniform muscle fiber orientation. The findings suggest that the finite element method is suitable for studying normal and pathological cardiac activation and has significant advantages over existing techniques.

  17. Finite element solution of two dimensional time dependent heat equation

    International Nuclear Information System (INIS)

    Maaz

    1999-01-01

    A Microsoft Windows based computer code, named FHEAT, has been developed for solving two dimensional heat problems in Cartesian and Cylindrical geometries. The programming language is Microsoft Visual Basic 3.0. The code makes use of Finite element formulation for spatial domain and Finite difference formulation for time domain. Presently the code is capable of solving two dimensional steady state and transient problems in xy- and rz-geometries. The code is capable excepting both triangular and rectangular elements. Validation and benchmarking was done against hand calculations and published results. (author)

  18. Finite element stress analysis of brick-mortar masonry under ...

    African Journals Online (AJOL)

    Stress analysis of a brick-mortar couplet as a substitute for brick wall structure has been performed by finite element method, and algorithm for determining the element stiffness matrix for a plane stress problem using the displacement approach was developed. The nodal displacements were derived for the stress in each ...

  19. Generalization of mixed multiscale finite element methods with applications

    Energy Technology Data Exchange (ETDEWEB)

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

    2016-08-01

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

  20. A review on application of finite element modelling in bone biomechanics

    Directory of Open Access Journals (Sweden)

    Sandeep Kumar Parashar

    2016-09-01

    Full Text Available In the past few decades the finite element modelling has been developed as an effective tool for modelling and simulation of the biomedical engineering system. Finite element modelling (FEM is a computational technique which can be used to solve the biomedical engineering problems based on the theories of continuum mechanics. This paper presents the state of art review on finite element modelling application in the four areas of bone biomechanics, i.e., analysis of stress and strain, determination of mechanical properties, fracture fixation design (implants, and fracture load prediction. The aim of this review is to provide a comprehensive detail about the development in the area of application of FEM in bone biomechanics during the last decades. It will help the researchers and the clinicians alike for the better treatment of patients and future development of new fixation designs.

  1. Biquartic Finite Volume Element Metho d Based on Lobatto-Guass Structure

    Institute of Scientific and Technical Information of China (English)

    Gao Yan-ni; Chen Yan-li

    2015-01-01

    In this paper, a biquartic finite volume element method based on Lobatto-Guass structure is presented for variable coefficient elliptic equation on rectangular partition. Not only the optimal H1 and L2 error estimates but also some super-convergent properties are available and could be proved for this method. The numer-ical results obtained by this finite volume element scheme confirm the validity of the theoretical analysis and the effectiveness of this method.

  2. Finite element concept to derive isostatic residual maps ...

    Indian Academy of Sciences (India)

    A new space-domain operator based on the shape function concept of finite element analysis has been developed to derive the ... not require explicit assumptions on isostatic models. Besides .... This information is implicit in the Bouguer ...

  3. Development of a 2-D Simplified P3 FEM Solver for Arbitrary Geometry Applications

    Energy Technology Data Exchange (ETDEWEB)

    Ryu, Eun Hyun; Joo, Han Gyu [Seoul National University, Seoul (Korea, Republic of)

    2010-10-15

    In the calculation of power distributions and multiplication factors in a nuclear reactor, the Finite Difference Method (FDM) and the nodal methods are primarily used. These methods are, however, limited to particular geometries and lack general application involving arbitrary geometries. The Finite Element Method (FEM) can be employed for arbitrary geometry application and there are numerous FEM codes to solve the neutron diffusion equation or the Sn transport equation. The diffusion based FEM codes have the drawback of inferior accuracy while the Sn based ones require a considerable computing time. This work here is to seek a compromise between these two by employing the simplified P3 (SP3) method for arbitrary geometry applications. Sufficient accuracy with affordable computing time and resources would be achieved with this choice of approximate transport solution when compared to full FEM based Pn or Sn solutions. For now only 2-D solver is considered

  4. Finite-element solution to multidimensional multisource electromagnetic problems in the frequency domain using non-conforming meshes

    Science.gov (United States)

    Soloveichik, Yury G.; Persova, Marina G.; Domnikov, Petr A.; Koshkina, Yulia I.; Vagin, Denis V.

    2018-03-01

    We propose an approach to solving multisource induction logging problems in multidimensional media. According to the type of induction logging tools, the measurements are performed in the frequency range of 10 kHz to 14 MHz, transmitter-receiver offsets vary in the range of 0.5-8 m or more, and the trajectory length is up to 1 km. For calculating the total field, the primary-secondary field approach is used. The secondary field is calculated with the use of the finite-element method (FEM), irregular non-conforming meshes with local refinements and a direct solver. The approach to constructing basis functions with the continuous tangential components (from Hcurl(Ω)) on the non-conforming meshes from the standard shape vector functions is developed. On the basis of this method, the algorithm of generating global matrices and a vector of the finite-element equation system is proposed. We also propose the method of grouping the logging tool positions, which makes it possible to significantly increase the computational effectiveness. This is achieved due to the compromise between the possibility of using the 1-D background medium, which is very similar to the investigated multidimensional medium for a small group, and the decrease in the number of the finite-element matrix factorizations with the increasing number of tool positions in one group. For calculating the primary field, we propose the method based on the use of FEM. This method is highly effective when the 1-D field is required to be calculated at a great number of points. The use of this method significantly increases the effectiveness of the primary-secondary field approach. The proposed approach makes it possible to perform modelling both in the 2.5-D case (i.e. without taking into account a borehole and/or invasion zone effect) and the 3-D case (i.e. for models with a borehole and invasion zone). The accuracy of numerical results obtained with the use of the proposed approach is compared with the one

  5. Node-based finite element method for large-scale adaptive fluid analysis in parallel environments

    International Nuclear Information System (INIS)

    Toshimitsu, Fujisawa; Genki, Yagawa

    2003-01-01

    In this paper, a FEM-based (finite element method) mesh free method with a probabilistic node generation technique is presented. In the proposed method, all computational procedures, from the mesh generation to the solution of a system of equations, can be performed fluently in parallel in terms of nodes. Local finite element mesh is generated robustly around each node, even for harsh boundary shapes such as cracks. The algorithm and the data structure of finite element calculation are based on nodes, and parallel computing is realized by dividing a system of equations by the row of the global coefficient matrix. In addition, the node-based finite element method is accompanied by a probabilistic node generation technique, which generates good-natured points for nodes of finite element mesh. Furthermore, the probabilistic node generation technique can be performed in parallel environments. As a numerical example of the proposed method, we perform a compressible flow simulation containing strong shocks. Numerical simulations with frequent mesh refinement, which are required for such kind of analysis, can effectively be performed on parallel processors by using the proposed method. (authors)

  6. Node-based finite element method for large-scale adaptive fluid analysis in parallel environments

    Energy Technology Data Exchange (ETDEWEB)

    Toshimitsu, Fujisawa [Tokyo Univ., Collaborative Research Center of Frontier Simulation Software for Industrial Science, Institute of Industrial Science (Japan); Genki, Yagawa [Tokyo Univ., Department of Quantum Engineering and Systems Science (Japan)

    2003-07-01

    In this paper, a FEM-based (finite element method) mesh free method with a probabilistic node generation technique is presented. In the proposed method, all computational procedures, from the mesh generation to the solution of a system of equations, can be performed fluently in parallel in terms of nodes. Local finite element mesh is generated robustly around each node, even for harsh boundary shapes such as cracks. The algorithm and the data structure of finite element calculation are based on nodes, and parallel computing is realized by dividing a system of equations by the row of the global coefficient matrix. In addition, the node-based finite element method is accompanied by a probabilistic node generation technique, which generates good-natured points for nodes of finite element mesh. Furthermore, the probabilistic node generation technique can be performed in parallel environments. As a numerical example of the proposed method, we perform a compressible flow simulation containing strong shocks. Numerical simulations with frequent mesh refinement, which are required for such kind of analysis, can effectively be performed on parallel processors by using the proposed method. (authors)

  7. Finite-element simulation of blood perfusion in muscle tissue during compression and sustained contraction.

    Science.gov (United States)

    Vankan, W J; Huyghe, J M; Slaaf, D W; van Donkelaar, C C; Drost, M R; Janssen, J D; Huson, A

    1997-09-01

    Mechanical interaction between tissue stress and blood perfusion in skeletal muscles plays an important role in blood flow impediment during sustained contraction. The exact mechanism of this interaction is not clear, and experimental investigation of this mechanism is difficult. We developed a finite-element model of the mechanical behavior of blood-perfused muscle tissue, which accounts for mechanical blood-tissue interaction in maximally vasodilated vasculature. Verification of the model was performed by comparing finite-element results of blood pressure and flow with experimental measurements in a muscle that is subject to well-controlled mechanical loading conditions. In addition, we performed simulations of blood perfusion during tetanic, isometric contraction and maximal vasodilation in a simplified, two-dimensional finite-element model of a rat calf muscle. A vascular waterfall in the venous compartment was identified as the main cause for blood flow impediment both in the experiment and in the finite-element simulations. The validated finite-element model offers possibilities for detailed analysis of blood perfusion in three-dimensional muscle models under complicated loading conditions.

  8. Finite Element Crash Simulations and Impact-Induced Injuries

    Directory of Open Access Journals (Sweden)

    Jaroslav Mackerle

    1999-01-01

    Full Text Available This bibliography lists references to papers, conference proceedings and theses/dissertations dealing with finite element simulations of crashes, impact-induced injuries and their protection that were published in 1980–1998. 390 citations are listed.

  9. Finite element simulation of thermal, elastic and plastic phenomena in fuel elements

    International Nuclear Information System (INIS)

    Soba, Alejandro; Denis, Alicia C.

    1999-01-01

    Taking as starting point an irradiation experiment of the first Argentine MOX fuel prototype, performed at the HFR reactor of Petten, Holland, the deformation suffered by the fuel element materials during burning has been numerically studied. Analysis of the pellet-cladding interaction is made by the finite element method. The code determines the temperature distribution and analyzes elastic and creep deformations, taking into account the dependency of the physical parameters of the problem on temperature. (author)

  10. Hybrid Discrete Element - Finite Element Simulation for Railway Bridge-Track Interaction

    Science.gov (United States)

    Kaewunruen, S.; Mirza, O.

    2017-10-01

    At the transition zone or sometimes called ‘bridge end’ or ‘bridge approach’, the stiffness difference between plain track and track over bridge often causes aggravated impact loading due to uneven train movement onto the area. The differential track settlement over the transition has been a classical problem in railway networks, especially for the aging rail infrastructures around the world. This problem is also additionally worsened by the fact that the construction practice over the area is difficult, resulting in a poor compaction of formation and subgrade. This paper presents an advanced hybrid simulation using coupled discrete elements and finite elements to investigate dynamic interaction at the transition zone. The goal is to evaluate the dynamic stresses and to better understand the impact dynamics redistribution at the bridge end. An existing bridge ‘Salt Pan Creek Railway Bridge’, located between Revesby and Kingsgrove, has been chosen for detailed investigation. The Salt Pan Bridge currently demonstrates crushing of the ballast causing significant deformation and damage. Thus, it’s imperative to assess the behaviours of the ballast under dynamic loads. This can be achieved by modelling the nonlinear interactions between the steel rail and sleeper, and sleeper to ballast. The continuum solid elements of track components have been modelled using finite element approach, while the granular media (i.e. ballast) have been simulated by discrete element method. The hybrid DE/FE model demonstrates that ballast experiences significant stresses at the contacts between the sleeper and concrete section. These overburden stress exists in the regions below the outer rails, identify fouling and permanent deformation of the ballast.

  11. Application of finite-element method to three-dimensional nuclear reactor analysis

    International Nuclear Information System (INIS)

    Cheung, K.Y.

    1985-01-01

    The application of the finite element method to solve a realistic one-or-two energy group, multiregion, three-dimensional static neutron diffusion problem is studied. Linear, quadratic, and cubic serendipity box-shape elements are used. The resulting sets of simultaneous algebraic equations with thousands of unknowns are solved by the conjugate gradient method, without forming the large coefficient matrix explicitly. This avoids the complicated data management schemes to store such a large coefficient matrix. Three finite-element computer programs: FEM-LINEAR, FEM-QUADRATIC and FEM-CUBIC were developed, using the linear, quadratic, and cubic box-shape elements respectively. They are self-contained, using simple nodal labeling schemes, without the need for separate finite element mesh generating routines. The efficiency and accuracy of these computer programs are then compared among themselves, and with other computer codes. The cubic element model is not recommended for practical usage because it gives almost identical results as the quadratic model, but it requires considerably longer computation time. The linear model is less accurate than the quadratic model, but it requires much shorter computation time. For a large 3-D problem, the linear model is to be preferred since it gives acceptable accuracy. The quadratic model may be used if improved accuracy is desired

  12. Linear and Nonlinear Finite Elements.

    Science.gov (United States)

    1983-12-01

    Metzler. Con/ ugte rapdent solution of a finite element elastic problem with high Poson rato without scaling and once with the global stiffness matrix K...nonzero c, that makes u(0) = 1. According to the linear, small deflection theory of the membrane the central displacement given to the membrane is not... theory is possible based on the approximations (l-y 2 )t = +y’ 2 +y𔃾 , (1-y𔃼)’ 1-y’ 2 - y" (6) that change eq. (5) to V𔃺) = , [yŖ(1 + y") - Qy𔃼

  13. Assembly of finite element methods on graphics processors

    KAUST Repository

    Cecka, Cris

    2010-08-23

    Recently, graphics processing units (GPUs) have had great success in accelerating many numerical computations. We present their application to computations on unstructured meshes such as those in finite element methods. Multiple approaches in assembling and solving sparse linear systems with NVIDIA GPUs and the Compute Unified Device Architecture (CUDA) are created and analyzed. Multiple strategies for efficient use of global, shared, and local memory, methods to achieve memory coalescing, and optimal choice of parameters are introduced. We find that with appropriate preprocessing and arrangement of support data, the GPU coprocessor using single-precision arithmetic achieves speedups of 30 or more in comparison to a well optimized double-precision single core implementation. We also find that the optimal assembly strategy depends on the order of polynomials used in the finite element discretization. © 2010 John Wiley & Sons, Ltd.

  14. FINELM: a multigroup finite element diffusion code

    International Nuclear Information System (INIS)

    Higgs, C.E.; Davierwalla, D.M.

    1981-06-01

    FINELM is a FORTRAN IV program to solve the Neutron Diffusion Equation in X-Y, R-Z, R-theta, X-Y-Z and R-theta-Z geometries using the method of Finite Elements. Lagrangian elements of linear or higher degree to approximate the spacial flux distribution have been provided. The method of dissections, coarse mesh rebalancing and Chebyshev acceleration techniques are available. Simple user defined input is achieved through extensive input subroutines. The input preparation is described followed by a program structure description. Sample test cases are provided. (Auth.)

  15. Hybrid Finite Element and Volume Integral Methods for Scattering Using Parametric Geometry

    DEFF Research Database (Denmark)

    Volakis, John L.; Sertel, Kubilay; Jørgensen, Erik

    2004-01-01

    n this paper we address several topics relating to the development and implementation of volume integral and hybrid finite element methods for electromagnetic modeling. Comparisons of volume integral equation formulations with the finite element-boundary integral method are given in terms of accu...... of vanishing divergence within the element but non-zero curl. In addition, a new domain decomposition is introduced for solving array problems involving several million degrees of freedom. Three orders of magnitude CPU reduction is demonstrated for such applications....

  16. An efficient structural finite element for inextensible flexible risers

    Science.gov (United States)

    Papathanasiou, T. K.; Markolefas, S.; Khazaeinejad, P.; Bahai, H.

    2017-12-01

    A core part of all numerical models used for flexible riser analysis is the structural component representing the main body of the riser as a slender beam. Loads acting on this structural element are self-weight, buoyant and hydrodynamic forces, internal pressure and others. A structural finite element for an inextensible riser with a point-wise enforcement of the inextensibility constrain is presented. In particular, the inextensibility constraint is applied only at the nodes of the meshed arc length parameter. Among the virtues of the proposed approach is the flexibility in the application of boundary conditions and the easy incorporation of dissipative forces. Several attributes of the proposed finite element scheme are analysed and computation times for the solution of some simplified examples are discussed. Future developments aim at the appropriate implementation of material and geometric parameters for the beam model, i.e. flexural and torsional rigidity.

  17. A finite element model of myocardial infarction using a composite material approach.

    Science.gov (United States)

    Haddad, Seyyed M H; Samani, Abbas

    2018-01-01

    Computational models are effective tools to study cardiac mechanics under normal and pathological conditions. They can be used to gain insight into the physiology of the heart under these conditions while they are adaptable to computer assisted patient-specific clinical diagnosis and therapeutic procedures. Realistic cardiac mechanics models incorporate tissue active/passive response in conjunction with hyperelasticity and anisotropy. Conventional formulation of such models leads to mathematically-complex problems usually solved by custom-developed non-linear finite element (FE) codes. With a few exceptions, such codes are not available to the research community. This article describes a computational cardiac mechanics model developed such that it can be implemented using off-the-shelf FE solvers while tissue pathologies can be introduced in the model in a straight-forward manner. The model takes into account myocardial hyperelasticity, anisotropy, and active contraction forces. It follows a composite tissue modeling approach where the cardiac tissue is decomposed into two major parts: background and myofibers. The latter is modelled as rebars under initial stresses mimicking the contraction forces. The model was applied in silico to study the mechanics of infarcted left ventricle (LV) of a canine. End-systolic strain components, ejection fraction, and stress distribution attained using this LV model were compared quantitatively and qualitatively to corresponding data obtained from measurements as well as to other corresponding LV mechanics models. This comparison showed very good agreement.

  18. Hermitian Mindlin Plate Wavelet Finite Element Method for Load Identification

    Directory of Open Access Journals (Sweden)

    Xiaofeng Xue

    2016-01-01

    Full Text Available A new Hermitian Mindlin plate wavelet element is proposed. The two-dimensional Hermitian cubic spline interpolation wavelet is substituted into finite element functions to construct frequency response function (FRF. It uses a system’s FRF and response spectrums to calculate load spectrums and then derives loads in the time domain via the inverse fast Fourier transform. By simulating different excitation cases, Hermitian cubic spline wavelets on the interval (HCSWI finite elements are used to reverse load identification in the Mindlin plate. The singular value decomposition (SVD method is adopted to solve the ill-posed inverse problem. Compared with ANSYS results, HCSWI Mindlin plate element can accurately identify the applied load. Numerical results show that the algorithm of HCSWI Mindlin plate element is effective. The accuracy of HCSWI can be verified by comparing the FRF of HCSWI and ANSYS elements with the experiment data. The experiment proves that the load identification of HCSWI Mindlin plate is effective and precise by using the FRF and response spectrums to calculate the loads.

  19. Rigid Finite Element Method in Analysis of Dynamics of Offshore Structures

    CERN Document Server

    Wittbrodt, Edmund; Maczyński, Andrzej; Wojciech, Stanisław

    2013-01-01

    This book describes new methods developed for modelling dynamics of machines commonly used in the offshore industry. These methods are based both on the rigid finite element method, used for the description of link deformations, and on homogeneous transformations and joint coordinates, which is applied to the modelling of multibody system dynamics. In this monograph, the bases of the rigid finite element method  and homogeneous transformations are introduced. Selected models for modelling dynamics of offshore devices are then verified both by using commercial software, based on the finite element method, as well as by using additional methods. Examples of mathematical models of offshore machines, such as a gantry crane for Blowout-Preventer (BOP) valve block transportation, a pedestal crane with shock absorber, and pipe laying machinery are presented. Selected problems of control in offshore machinery as well as dynamic optimization in device control are also discussed. Additionally, numerical simulations of...

  20. Efficient Finite Element Models for Calculation of the No-load losses of the Transformer

    Directory of Open Access Journals (Sweden)

    Kamran Dawood

    2017-10-01

    Full Text Available Different transformer models are examined for the calculation of the no-load losses using finite element analysis. Two-dimensional and three-dimensional finite element analyses are used for the simulation of the transformer. Results of the finite element method are also compared with the experimental results. The Result shows that 3-dimensional provide high accuracy as compared to the 2 dimensional full and half model. However, the 2-dimensional half model is the less time-consuming method as compared to the 3 and 2-dimensional full model. Simulation time duration taken by the different models of the transformer is also compared. The difference between the 3-dimensional finite element method and experimental results are less than 3%. These numerical methods can help transformer designers to minimize the development of the prototype transformers.