23 research outputs found

    Discontinuous Galerkin approximations in computational mechanics: hybridization, exact geometry and degree adaptivity

    Get PDF
    Discontinuous Galerkin (DG) discretizations with exact representation of the geometry and local polynomial degree adaptivity are revisited. Hybridization techniques are employed to reduce the computational cost of DG approximations and devise the hybridizable discontinuous Galerkin (HDG) method. Exact geometry described by non-uniform rational B-splines (NURBS) is integrated into HDG using the framework of the NURBS-enhanced finite element method (NEFEM). Moreover, optimal convergence and superconvergence properties of HDG-Voigt formulation in presence of symmetric second-order tensors are exploited to construct inexpensive error indicators and drive degree adaptive procedures. Applications involving the numerical simulation of problems in electrostatics, linear elasticity and incompressible viscous flows are presented. Moreover, this is done for both high-order HDG approximations and the lowest-order framework of face-centered finite volumes (FCFV).Peer ReviewedPostprint (author's final draft

    NURBS-Enhanced Finite Element Method (NEFEM)

    Get PDF
    Aquesta tesi proposa una millora del clàssic mètode dels elements finits (finite element method, FEM) per a un tractament eficient de dominis amb contorns corbs: el denominat NURBS-enhanced finite element method (NEFEM). Aquesta millora permet descriure de manera exacta la geometría mitjançant la seva representació del contorn CAD amb non-uniform rational B-splines (NURBS), mentre que la solució s'aproxima amb la interpolació polinòmica estàndard. Per tant, en la major part del domini, la interpolació i la integració numèrica són estàndard, retenint les propietats de convergència clàssiques del FEM i facilitant l'acoblament amb els elements interiors. Només es requereixen estratègies específiques per realitzar la interpolació i la integració numèrica en elements afectats per la descripció del contorn mitjançant NURBS.La implementació i aplicació de NEFEM a problemes que requereixen una descripció acurada del contorn són, també, objectius prioritaris d'aquesta tesi. Per exemple, la solució numèrica de les equacions de Maxwell és molt sensible a la descripció geomètrica. Es presenta l'aplicació de NEFEM a problemes d'scattering d'ones electromagnètiques amb una formulació de Galerkin discontinu. S'investiga l'habilitat de NEFEM per obtenir solucions precises amb malles grolleres i aproximacions d'alt ordre, i s'exploren les possibilitats de les anomenades malles NEFEM, amb elements que contenen singularitats dintre d'una cara o aresta d'un element. Utilitzant NEFEM, la mida de la malla no està controlada per la complexitat de la geometria. Això implica una dràstica diferència en la mida dels elements i, per tant, suposa un gran estalvi tant des del punt de vista de requeriments de memòria com de cost computacional. Per tant, NEFEM és una eina poderosa per la simulació de problemes tridimensionals a gran escala amb geometries complexes. D'altra banda, la simulació de problemes d'scattering d'ones electromagnètiques requereix mecanismes per aconseguir una absorció eficient de les ones scattered. En aquesta tesi es discuteixen, optimitzen i comparen dues tècniques en el context de mètodes de Galerkin discontinu amb aproximacions d'alt ordre.La resolució numèrica de les equacions d'Euler de la dinàmica de gasos és també molt sensible a la representació geomètrica. Quan es considera una formulació de Galerkin discontinu i elements isoparamètrics lineals, una producció espúria d'entropia pot evitar la convergència cap a la solució correcta. Amb NEFEM, l'acurada imposició de la condició de contorn en contorns impenetrables proporciona resultats precisos inclús amb una aproximació lineal de la solució. A més, la representació exacta del contorn permet una imposició adequada de les condicions de contorn amb malles grolleres i graus d'interpolació alts. Una propietat atractiva de la implementació proposada és que moltes de les rutines usuals en un codi d'elements finits poden ser aprofitades, per exemple rutines per realitzar el càlcul de les matrius elementals, assemblatge, etc. Només és necessari implementar noves rutines per calcular les quadratures numèriques en elements corbs i emmagatzemar el valor de les funciones de forma en els punts d'integració. S'han proposat vàries tècniques d'elements finits corbs a la literatura. En aquesta tesi, es compara NEFEM amb altres tècniques populars d'elements finits corbs (isoparamètics, cartesians i p-FEM), des de tres punts de vista diferents: aspectes teòrics, implementació i eficiència numèrica. En els exemples numèrics, NEFEM és, com a mínim, un ordre de magnitud més precís comparat amb altres tècniques. A més, per una precisió desitjada NEFEM és també més eficient: necessita un 50% dels graus de llibertat que fan servir els elements isoparamètrics o p-FEM per aconseguir la mateixa precisió. Per tant, l'ús de NEFEM és altament recomanable en presència de contorns corbs i/o quan el contorn té detalls geomètrics complexes.This thesis proposes an improvement of the classical finite element method (FEM) for an efficient treatment of curved boundaries: the NURBSenhanced FEM (NEFEM). It is able to exactly represent the geometry by means of the usual CAD boundary representation with non-uniform rational Bsplines (NURBS), while the solution is approximated with a standard piecewise polynomial interpolation. Therefore, in the vast majority of the domain, interpolation and numerical integration are standard, preserving the classical finite element (FE) convergence properties, and allowing a seamless coupling with standard FEs on the domain interior. Specifically designed polynomial interpolation and numerical integration are designed only for those elements affected by the NURBS boundary representation.The implementation and application of NEFEM to problems demanding an accurate boundary representation are also primary goals of this thesis. For instance, the numerical solution of Maxwell's equations is highly sensitive to geometry description. The application of NEFEM to electromagnetic scattering problems using a discontinuous Galerkin formulation is presented. The ability of NEFEM to compute an accurate solution with coarse meshes and high-order approximations is investigated, and the possibilities of NEFEM meshes, with elements containing edge or corner singularities, are explored. With NEFEM, the mesh size is no longer subsidiary to geometry complexity, and depends only on the accuracy requirements on the solution, whereas standard FEs require mesh refinement to properly capture the geometry. This implies a drastic difference in mesh size that results in drastic memory savings, and also important savings in computational cost. Thus, NEFEM is a powerful tool for large-scale scattering simulations with complex geometries in three dimensions. Another key issue in the numerical solution of electromagnetic scattering problems is using a mechanism to perform the absorption of outgoing waves. Two perfectly matched layers are discussed, optimized and compared in a high-order discontinuous Galerkin framework.The numerical solution of Euler equations of gas dynamics is also very sensitive to geometry description. Using a discontinuous Galerkin formulation and linear isoparametric elements, a spurious entropy production may prevent convergence to the correct solution. With NEFEM, the exact imposition of the solid wall boundary condition provides accurate results even with a linear approximation of the solution. Furthermore, the exact boundary representation allows using coarse meshes, but ensuring the proper implementation of the solid wall boundary condition. An attractive feature of the proposed implementation is that the usual routines of a standard FE code can be directly used, namely routines for the computation of elemental matrices and vectors, assembly, etc. It is only necessary to implement new routines for the computation of numerical quadratures in curved elements and to store the value of shape functions at integration points. Several curved FE techniques have been proposed in the literature. In this thesis, NEFEM is compared with some popular curved FE techniques (namely isoparametric FEs, cartesian FEs and p-FEM), from three different perspectives: theoretical aspects, implementation and performance. In every example shown, NEFEM is at least one order of magnitude more accurate compared to other techniques. Moreover, for a desired accuracy NEFEM is also computationally more efficient. In some examples, NEFEM needs only 50% of the number of degrees of freedom required by isoparametric FEs or p-FEM. Thus, the use of NEFEM is strongly recommended in the presence of curved boundaries and/or when the boundary of the domain has complex geometric details

    Numerical integration over 2D NURBS-shaped domains with applications to NURBS-enhanced FEM

    Get PDF
    This paper focuses on the numerical integration of polynomial functions along non-uniform rational B-splines (NURBS) curves and over 2D NURBS-shaped domains, i.e. domains with NURBS boundaries. The integration of the constant function f=1 is of special interest in computer aided design software and the integration of very high-order polynomials is a key aspect in the recently proposed NURBS-enhanced finite element method (NEFEM). Several well-known numerical quadratures are compared for the integration of polynomials along NURBS curves, and two transformations for the definition of numerical quadratures in triangles with one edge defined by a trimmed NURBS are proposed, analyzed and compared. When exact integration is feasible, explicit formulas for the selection of the number of integration points are deduced. Numerical examples show the influence of the number of integration points in NEFEM computations.Peer ReviewedPostprint (author's final draft

    Solution of geometrically parametrised problems within a CAD environment via model order reduction

    Get PDF
    The main objective of this work is to describe a general and original approach for computing an off-line solution for a set of parameters describing the geometry of the domain. That is, a solution able to include information for different geometrical parameter values and also allowing to compute readily the sensitivities. Instead of problem dependent approaches, a general framework is presented for standard engineering environments where the geometry is defined by means of NURBS. The parameters controlling the geometry are now the control points characterising the NURBS curves or surfaces. The approach proposed here, valid for 2D and 3D scenarios, allows a seamless integration with CAD preprocessors. The proper generalised decomposition (PGD), which is applied here to compute explicit geometrically parametrised solutions, circumvents the curse of dimensionality. Moreover, optimal convergence rates are shown for PGD approximations of incompressible flows

    NEFEM for EULER equations

    Get PDF
    An improvement of the classical finite element method is proposed in [1], the NURBS-Enhanced Finite Element Method (NEFEM). It considers an exact representation of the geometry by means of the usual CAD description of the boundary with Non-Uniform Rational B-Splines (NURBS). For elements not intersecting the boundary, a standard finite element interpolation and numerical integration is used. Specifically designed piecewise polynomial interpolation and numerical integration are proposed for those finite elements intersecting the NURBS boundary. In [2] a numerical example involving an electromagnetic scattering application, is used in order to demonstrate the applicability and behavior of the proposed methodology. The results are encouraging and show that the NEFEM is more accurate than the corresponding isoparametric finite elements, using a Discontinuous Galerkin (DG) formulation. Recent studies also demonstrate that, for a desired precision, the NEFEM is also more efficient in terms of number of degrees of freedom, and in terms of CPU time. In the present work the NEFEM is reviewed and applied to the solution of the Euler equations of a compressible inviscid fluid. This set of hyperbolic equations represents a more challenging application for the NEFEM because the nonlinearity of the hyperbolic system and the sensitivity of DG formulations to the imposition of the wall boundary condition in curved domains.Peer Reviewe

    3D nurbs-enhanced finite element method

    Get PDF
    An improvement of the classical finite element method is proposed in [1], the NURBS-Enhanced Finite Element Method (NEFEM). It is able to exactly represent the geometry by means of the usual CAD description of the boundary with Non-Uniform Rational B-Splines (NURBS). For elements not intersecting the boundary, a standard finite element interpolation and numerical integration is used. But elements intersecting the NURBS boundary need a specifically designed piecewise polynomial interpolation and numerical integration. This document presents preliminary work on the 3D extension of NEFEM

    NURBS-Enhanced FEM para problemas de scattering

    Get PDF
    En [1] R. Sevilla, A. Huerta y S. Fernández-Méndez , NURBS-Enhanced Finite Element Method (NEFEM) Libro de Resúmenes (CEDYA 2005). Universidad Carlos III de Madrid, 2005 se presenta el NURBS-Enhanced Finite Element Method (NEFEM), una mejora del clásico método de los elementos finitos que permite trabajar con el modelo geométrico exacto, independientemente de la discretización espacial utilizada. En [1] ] R. Sevilla, A. Huerta y S. Fernández-Méndez , NURBS-Enhanced Finite Element Method (NEFEM) Libro de Resúmenes (CEDYA 2005). Universidad Carlos III de Madrid, 2005 se desarrollan nuevas estrategias que permiten realizar la interpolación y la integración numérica para los elementos que tienen una arista definida mediante Non-Uniform Rational B-Splines (NURBS) trimadas, ver [2] L. Piegl, W. Tiller, The NURBS Book, Springer-Verlag, London, 1995.. En este trabajo se plantea la aplicación del NEFEM, con una formulación de Galerkin discontinuo (DG), para la resolución de las ecuaciones de Maxwell. La importancia de trabajar con un buen modelo geométrico está justificada en aplicaciones de scattering de ondas electromagnéticas, donde la geometría del obstáculo es determinante para poder obtener resultados precisos. Mediante ejemplos numéricos se observa que el NEFEM presenta importantes ventajas respecto a los clásicos elementos isoparamétricos. Para una malla fijada el NEFEM es entre 11 y 15 veces más preciso. Por otro lado, para una precisión fijada, el NEFEM también resulta más eficiente, ya que sólo requiere el 38 % de grados de libertad y el 75 % del tiempo de CPU consumido por el método DG estándar.Ministerio de Educación y CienciaUniversitat Politécnica de Cataluny

    A superconvergent HDG method for stokes flow with strongly enforced symmetry of the stress tensor

    Get PDF
    The final publication is available at Springer via http://dx.doi.org/10.1007/s10915-018-0855-yThis work proposes a superconvergent hybridizable discontinuous Galerkin (HDG) method for the approximation of the Cauchy formulation of the Stokes equation using same degree of polynomials for the primal and mixed variables. The novel formulation relies on the well-known Voigt notation to strongly enforce the symmetry of the stress tensor. The proposed strategy introduces several advantages with respect to the existing HDG formulations. First, it remedies the suboptimal behavior experienced by the classical HDG method for formulations involving the symmetric part of the gradient of the primal variable. The optimal convergence of the mixed variable is retrieved and an element-by-element postprocess procedure leads to a superconvergent velocity field, even for low-order approximations. Second, no additional enrichment of the discrete spaces is required and a gain in computational efficiency follows from reducing the quantity of stored information and the size of the local problems. Eventually, the novel formulation naturally imposes physical tractions on the Neumann boundary. Numerical validation of the optimality of the method and its superconvergent properties is performed in 2D and 3D using meshes of different element types.Peer ReviewedPostprint (author's final draft

    A second-order face-centred finite volume method for elliptic problems

    Get PDF
    A second-order face-centred finite volume method (FCFV) is proposed. Contrary to the more popular cell-centred and vertex-centred finite volume (FV) techniques, the proposed method defines the solution on the faces of the mesh (edges in two dimensions). The method is based on a mixed formulation and therefore considers the solution and its gradient as independent unknowns. They are computed solving a cell-by-cell problem after the solution at the faces is determined. The proposed approach avoids the need of reconstructing the solution gradient, as required by cell-centred and vertex-centred FV methods. This strategy leads to a method that is insensitive to mesh distortion and stretching. The current method is second-order and requires the solution of a global system of equations of identical size and identical number of non-zero elements when compared to the recently proposed first-order FCFV. The formulation is presented for Poisson and Stokes problems. Numerical examples are used to illustrate the approximation properties of the method as well as to demonstrate its potential in three dimensional problems with complex geometries. The integration of a mesh adaptive procedure in the FCFV solution algorithm is also presented

    Nonintrusive proper generalised decomposition for parametrised incompressible flow problems in OpenFOAM

    Get PDF
    The computational cost of parametric studies currently represents the major limitation to the application of simulation-based engineering techniques in a daily industrial environment. This work presents the first nonintrusive implementation of the proper generalised decomposition (PGD) in OpenFOAM, for the approximation of parametrised laminar incompressible Navier–Stokes equations. The key feature of this approach is the seamless integration of a reduced order model (ROM) in the framework of an industrially validated computational fluid dynamics software. This is of special importance in an industrial environment because in the online phase of the PGD ROM the description of the flow for a specific set of parameters is obtained simply via interpolation of the generalised solution, without the need of any extra solution step. On the one hand, the spatial problems arising from the PGD separation of the unknowns are treated using the classical solution strategies of OpenFOAM, namely the semi-implicit method for pressure linked equations (SIMPLE) algorithm. On the other hand, the parametric iteration is solved via a collocation approach. The resulting ROM is applied to several benchmark tests of laminar incompressible Navier–Stokes flows, in two and three dimensions, with different parameters affecting the flow features. Eventually, the capability of the proposed strategy to treat industrial problems is verified by applying the methodology to a parametrised flow control in a realistic geometry of interest for the automotive industry
    corecore