Skip to main content
  • Research Article
  • Open access
  • Published:

Finite increment calculus (FIC): a framework for deriving enhanced computational methods in mechanics

Abstract

In this paper we present an overview of the possibilities of the finite increment calculus (FIC) approach for deriving computational methods in mechanics with improved numerical properties for stability and accuracy. The basic concepts of the FIC procedure are presented in its application to problems of advection-diffusion-reaction, fluid mechanics and fluid-structure interaction solved with the finite element method (FEM). Examples of the good features of the FIC/FEM technique for solving some of these problems are given. A brief outline of the possibilities of the FIC/FEM approach for error estimation and mesh adaptivity is given.

Background

The finite increment calculus (FIC) (sometimes called finite calculus, in short) was proposed by Oñate [1] as a conceptual framework for deriving stabilized numerical methods [mainly the finite element method (FEM)] for solving advective–diffusive transport and fluid compressible flow problems in mechanics for situations where numerical methods typically fail (i.e., high Peclet/Reynolds numbers and incompressible situations) [2, 3].

The essence of the FIC approach lays in solving the governing differential equations in mechanics written in a modified form, using any discretization method such as the Galerkin finite element (FE) method, any standard finite difference (FD) scheme, the finite volume (FV) method, meshless methods, etc. The FIC modified governing equations are obtained by writing the equations for balance of heat, momentum and mass in a space-time domain of finite incremental size, and not in a domain of infinitesimal size, as it is usually done.

Accounting for the finiteness of the balance space-time domain introduces naturally additional terms in the classical differential equations of continuum mechanics, which how become a function of the balance domain dimensions. The merit of the modified governing equations derived via FIC is that they are a natural starting point for deriving stabilized numerical schemes. Moreover, the different stabilized FE, FD and FV methods typically used in practice can be recovered using FIC.

The FIC technique has been used in conjunction with the finite element method (FEM) for deriving stabilized FIC/FEM procedures for a wide range of problems in advective–diffusive-reactive transport, fluid mechanics, incompressible solids and fluid-structure interaction (FSI) situations, among others [1, 428]. The FIC approach has also been used in conjunction with the meshless finite point method for solving some of these problems [13, 2931].

The layout of the paper is the following. In the next section the main concepts of the FIC method are introduced. Details of the FIC approach for advection–diffusion-reaction problems solved with the FEM are presented. Then the possibilities of the FIC/FEM technique in fluid and solid mechanics and FSI problems solved with the particle finite element method (PFEM) are outlined. Examples of applications are given for some of the problems considered. Finally, a brief outline of the possibilities of the FIC/FEM approach for error estimation and mesh adaptivity is given.

Basic ideas of the FIC approach

Let us consider a steady-state advection–diffusion problem in a 1D domain \(\Omega \) of length L. The equation of balance of fluxes in a subdomain of size d belonging to \(\Omega \) (Fig. 1) is written as

$$\begin{aligned} q_A - q_B=0 \end{aligned}$$
(1)

where \(q_A\) and \(q_B\) are the incoming and outgoing fluxes at points A and B, respectively. The flux q includes both the advective and diffusive terms; i.e., \(q=\rho c v\phi - k{d\phi \over dx}\), where \(\phi \) is the transported variable (i.e., the temperature in a thermal problem), v is the velocity \(\rho , c\) and k the density, the specific flux parameter and the diffusitivity of the material, respectively.

Fig. 1
figure 1

Equilibrium of fluxes in a space balance domain of finite size

Let us express now the fluxes \(q_A\) and \(q_B\) in terms of the flux at an arbitrary point C within the balance domain (Fig. 1). Expanding \(q_A\) and \(q_B\) in Taylor series around point C up to second order terms gives

$$\begin{aligned}&q_A= q_C - d_1 \frac{dq}{d x}\vert _C+ \frac{d^2_1}{2}\frac{d^2q}{dx^2}\vert _C + O(d^3_1) ,\quad q_B= q_C + d_2 \frac{dq}{d x}\vert _C+\frac{d^2_2}{2}\frac{d^2q}{dx^2}\vert _C + O(d^3_2) \end{aligned}$$
(2)

Substituting Eq. (2) into Eq. (1) gives after simplification and neglecting higher order terms

$$\begin{aligned} \frac{dq}{dx}-\underline{\frac{h}{2} \frac{d^2q}{dx^2}}=0 \end{aligned}$$
(3)

where \(h=d_1-d_2\) and all the derivatives are computed at the arbitrary point C.

Standard calculus theory assumes that the balance domain d is of infinitesimal size. Hence, the underlined term in Eq. (3) can be neglected and the resulting flux balance equation is simply \({dq\over dx}=0\). In FIC we will relax this assumption and allow the space balance domain to have a finite size. The new balance Eq. (3) incorporates the underlined term which introduces the characteristic length h. Obviously, accounting for higher order terms in the Taylor expansions of Eq. (2) would lead to additional terms in Eq. (3) incorporating higher powers of h.

Distance h in Eq. (3) can be interpreted as a free parameter depending on the location of point C within the balance domain. Note that \(-d\le h\le d\) and, hence, h can take a negative value. At the discrete solution level the domain d should be replaced by the balance domain around a node. This gives for an equal size discretization \(-l^e\le h \le l^e\) where \(l^e\) is the element or cell dimension. The fact that Eq. (3) is the exact flux balance equation (up to second order terms) for any 1D domain of finite size and that the position of point C is arbitrary, can be used to derive numerical schemes with enhanced properties. This goal can be reached by computing the characteristic length parameter h using an adequate “optimality” condition; for instance, in the FEM context we can look for the elemental or nodal value of h that ensures a prescribed (small) error in the numerical solution [1, 10, 32]. In some cases, the optimal value of h for each element leading to an exact nodal solution can be found [1, 6, 21, 28, 32].

Applications to the 1D convection–diffusion problems

Consider, for instance, Eq. (3) applied to the 1D advection–diffusion problem in a 1D domain of length L. Neglecting the third order derivatives, Eq. (3) can be rewritten in terms of \(\phi \) as

$$\begin{aligned} -v \frac{d\phi }{dx}+\left( k+\frac{\rho c v h}{2}\right) \frac{d^2\phi }{dx^2}=0;\quad 0\le x \le L \end{aligned}$$
(4)

We see that the FIC method introduces naturally an additional diffusion term in the standard advection–diffusion equation. This is the basis of the popular “artificial diffusion” procedure [13] where the characteristic length h is expressed as a function of the cell or element dimension. The critical value of h can be computed by ensuring that the solution has a physically meaning (i.e., \(\phi _i \ge 0\) for the Dirichlet problem with non negative prescribed values of \(\phi \) at \(x=0\) and \(x=L\)). For an equal size FEM discretization this gives \(h\ge \left( 1 - {1\over \gamma }\right) l^e\), where \(\gamma = \rho c {vl^e\over 2k}\) is the element Peclet number. The inequality applies for \(\gamma > 0\) and it should be reversed for \(\gamma < 0\). Also h is taken to be zero for \(\vert \gamma \vert < 1\). The optimal value of h for all the elements leading to exact nodal values can also be found for this simple case as \(h=\left( \coth \gamma - {1\over \gamma }\right) l^e\) [13]. The same results are obtained using the FD method with a central difference scheme, where \(l^e\) is now the cell dimension [1, 3].

Equation (3) can be extended to account for source terms. The FIC governing equation can then be written in compact form as

$$\begin{aligned} r- \underline{\frac{h}{2} \frac{dr}{dx}}=0; \qquad r : = \rho c v \frac{d\phi }{dx}- \frac{d}{dx}\left( k \frac{d\phi }{dx}\right) - Q \end{aligned}$$
(5)

where Q is the external source.

Boundary conditions

The FIC governing equations are completed with the standard Dirichlet condition prescribing the value of \(\phi \) at the boundary \(\Gamma _\phi \) (i.e., \(\phi = \phi ^p =0\) at \(\Gamma _\phi \)).

For consistency a FIC form of the Neumann boundary condition should be used. This can be obtained by invoking balance of fluxes in a domain of finite size next to the boundary \(\Gamma _q\). The FIC Neumann boundary condition when the external (diffusive) flux is prescribed to a value \(q^p\) is [1]

$$\begin{aligned} k \frac{d\phi }{dx}+q^p + \underline{\frac{h}{2}r}=0 \quad \hbox {at } \Gamma _q \end{aligned}$$
(6)

Note that for \(h=0\) the standard Neumann boundary condition for prescribed diffusive flux is obtained.

We emphasize that the relevant feature of the FIC procedure is that the underlined terms in Eqs. (5) and (6) introduce the necessary stabilization in the discrete solution using whatever numerical scheme.

The FIC method in space-time

The time dimension can be simply accounted for in the FIC method by considering the balance equation in a space-time slab domain. Quite generally the FIC governing equation over the analysis domain \(\Omega \) can be written for any problem in mechanics as [1]

$$\begin{aligned} r_i - \underline{\frac{h_{ij}}{2}{\partial r_i \over \partial x_j}}+s_g \underline{\frac{\delta }{2}{\partial r_i \over \partial t}}=0 \quad \hbox {in }\Omega ,\quad \begin{array}{l} i=1,n_b\\ j=1,n_d \end{array} \end{aligned}$$
(7)

where \(r_i\) is the ith standard differential equation of the infinitesimal theory, \(h_{ij}\) are characteristic length parameters for the ith balance equations and the jth space direction, \(\delta \) is a finite time increment parameter and t the time; \(n_b\) and \(n_d\) are respectively the number of balance equations and the number of space dimensions of the problem. Clearly for the transient case the initial value of the solution must be specified.

In Eq. (7) \(s_g\) is a sign parameter that can take the values \(+1\) or \(-1\). The value of \(s_g\) leads to FIC time integration schemes with distinct numerical properties [33].

The usual sum convention for repeated indexes is used in Eq. (7) and in the following, unless otherwise specified.

For the transient advection-diffusion problem, Eq. (7) is particularized as

$$\begin{aligned}&r- \frac{h_j}{2}{\partial r \over \partial x_j}+s_g \frac{\delta }{2}{\partial r \over \partial t}=0\quad \hbox {with} \quad r:=\rho c\left( \displaystyle {\partial \phi \over \partial t}+v_j \displaystyle {\partial \phi \over \partial x_j}\right) - \displaystyle \frac{d}{dx_j}\left( k \displaystyle \frac{d\phi }{dx_j}\right) - Q\nonumber \\&\quad j=1,n_d \end{aligned}$$
(8)

Applications of the space-time FIC method to the transient solution of advection–diffusion problems with the FEM can be found in [11].

A conceptual interpretation of FIC

Let us consider the solution of a physical problem, such as obtaining the steady state distribution of the temperature \(\phi \) in a domain \(\Omega \), governed by a differential equation \(r(\phi ) =0\) in \(\Omega \) with the corresponding boundary conditions. The “exact” (analytical) solution of the problem is a function giving the sought distribution of the temperature \(\phi \) for any value of the geometrical and physical parameters of the problem. Since the analytical solution is difficult to find (practically impossible for real situations), an approximate numerical solution is found \(\phi \simeq {\hat{\phi }}\) by solving the problem \({\hat{r}} =0\), with \({\hat{r}} = r({\hat{\phi }} )\), using a particular discretization method (i.e. the FE method) leading to the temperature distribution in \(\Omega \) is for specific values of the geometrical and physical parameters. The accuracy of the numerical solution depends on the discretization parameters, such as the number of elements and the particular FE method chosen. Figure 2 shows a schematic representation of the distributions of \({\hat{\phi }}\) along a line for different FE discretizations \(M_1,M_2,\ldots , M_n\) where \(M_1\) and \(M_n\) are the coarser and finer meshes, respectively. Clearly for n sufficiently large, a good approximation of \(\phi \) to the “exact” solution will be obtained. Also, for \(M_\infty \) the numerical solution \({\hat{\phi }}\) will coincide with the exact one \(\phi \) at all points in \(\Omega \). Indeed in some problems the \(M_\infty \) solution can be found at the nodes by a “clever” choice of the FIC parameters in the discretized problem [1, 6, 10, 21, 28, 32].

Fig. 2
figure 2

Schematic representation of the numerical solution of a physical problem using standard infinitesimal calculus and the finite increment calculus (FIC) method

The problem arises when for some (typically coarse) discretizations the numerical solution provides non physical or very inaccurate values of \( {\hat{\phi }}\). The numerical method is then said to be unstable. A situation of this kind is represented by curves \(M_1\) and \(M_2\) of the left hand side of Fig. 2. These unstabilities disappear by an appropriate mesh refinement (curves \(M_3,M_4, \ldots \)) at the obvious increase of the computational cost.

In the FIC formulation the starting point are the modified differential equations of the problem in \(\Omega \) and the corresponding FIC Neumann boundary condition as previously described. The FIC governing equations can not be used to find an analytical solution, \(\phi (x)\), for the physical problem. However, the numerical solution of the FIC equations can be readily found. What is interesting and useful is that, by adequately choosing the values of the characteristic length parameters, the numerical solution of the FIC equations will be always stable for any discretization chosen.

This process is schematically represented in Fig. 2 where it is shown that the numerical oscillations for the coarser discretizations \(M_1\) and \(M_2\) disappear when using the FIC procedure.

In summary the FIC approach allows us to obtain a better numerical solution for a given discretization. Indeed, as for the standard infinitesimal case, the FIC numerical solution for \(M_\infty \) will yield the (unreachable) exact analytical solution and this ensures the consistency of the method.

The FIC method has been classified in [6] as a particular case of “modified equations methods” where the standard differential equations are first augmented using physical concepts and then discretized using a numerical technique. An interpretation of the FIC/FEM equations as a residual correction method is presented in [16].

FIC/FEM solution of advection–diffusion-reaction problems

The FIC form of the advection–diffusion-reaction equation is written (neglecting the FIC term in time) as [21, 28]

$$\begin{aligned} r- \underline{\frac{h_j}{2}{\partial r \over \partial x_j}} =0,\quad r:= \rho c \left( {\partial \phi \over \partial t} + v_j {\partial \phi \over \partial x_j} \right) -{\partial \over \partial x_j} \left( k {\partial \phi \over \partial x_j}\right) + s \phi - Q,\quad j=1,n_d \end{aligned}$$
(9)

The new physical parameter in Eq. (9) is the reaction parameter s (\(s>0\) is the absorption or dissipation parameter and \(s<0\) is the production parameter).

The boundary conditions at the Dirichlet and Neumann boundary conditions are prescribed as explained in a previous section. Recall that the FIC form of the Neumann boundary conditions as defined in Eq. (6) should be used for consistency of the FIC procedure.

Equation (9) solves the following particular problems:

  1. (i)

    Advection–diffusion (\(s=0\))

  2. (ii)

    Helmholtz (\(v=0\), \(s<0\))

  3. (iii)

    Advection-reaction (\(k=0\))

  4. (iv)

    Diffusion-reaction (\(v=0\))

Finite element discretization

A finite element interpolation of the unknown \(\phi \) can be written as

$$\begin{aligned} \phi \simeq {\hat{\phi }} =\sum \limits _{i=1}^N N_i {\hat{\phi }}_i (t) \end{aligned}$$
(10)

where \(N_i (x) \) are the space shape functions and \({\hat{\phi }}_i\) are the nodal values of the approximate function \({\hat{\phi }}\) and N is the number of nodes in the mesh [13].

Application of the Galerkin FE method in space to Eqs. (9) and (6) gives, after integrating by parts the term \({\pmb \nabla }r\) (and neglecting the space derivatives of the characteristic lengths \(h_j\))

$$\begin{aligned} \int _\Omega N_i {\hat{r}} d\Omega + \int _{\Gamma _q} N_i ({\mathbf {n}}^T {\mathbf {D}} {\pmb \nabla }{\hat{\phi }} +\bar{q}^p)d\Gamma + \sum \limits _e {1\over 2} \int _{\Omega ^e} {\mathbf {h}}^T{\pmb \nabla } N_i {\hat{r}} d\Omega =0 \end{aligned}$$
(11)

In Eq. (11) \({\hat{r}} = r ({\hat{\phi }} )\) is the residual of the FE approximation of the infinitesimal governing equation, D is the standard diffusivity matrix (\({\mathbf {D}}=k {\mathbf {I}}_3\) for 3D isotropic problems where \({\mathbf {I}}_3\) is the unit matrix), \({\mathbf {n}}\) is the unit vector normal to the boundary, \({\mathbf {h}} = [h_1,h_2,h_3]^T\) is the characteristic length vector and \(\Omega ^e\) is the element domain.

The last integral in Eq. (11) has been expressed as a sum of the element contributions to allow for interelement discontinuities in the term \({\pmb \nabla }{\hat{r}}\).

Note that the residual terms have disappeared at the Neumann boundary integral in Eq. (11). This is due to taking into account the FIC term in Eq. (6).

Integrating by parts the diffusive terms in the first integral of Eq. (11) gives

$$\begin{aligned}&\int _\Omega N_i \left[ \rho c \left( {\partial {\hat{\phi }} \over \partial t}+ {\mathbf {v}}^T \nabla {\hat{\phi }}\right) + {\pmb \nabla }^T N_i {\mathbf {D}}{\pmb \nabla }{\hat{\phi }} +s {\hat{\phi }}\right] d\Omega + \sum \limits _e {1\over 2} \int _{\Omega ^e} {\mathbf {h}}^T{\pmb \nabla } N_i {\hat{r}} d\Omega \nonumber \\&\quad - \int _\Omega N_i Q d\Omega +\int _{\Gamma _q} N_i \bar{q}^p d\Gamma =0 \end{aligned}$$
(12)

where \({\mathbf {v}} = [v_1,v_2,v_3]^T\) is the velocity vector. In matrix form

$$\begin{aligned} {\mathbf {C}} \dot{\mathbf {a}} + {\mathbf {K}}{\mathbf {a}}={\mathbf {f}}\quad \hbox {with} \quad {\mathbf {a}} = [{\hat{\phi }}_1,{\hat{\phi }}_2 ,\cdots , {\hat{\phi }}_N ]^T \quad \hbox {and} \quad \dot{\mathbf {a}} := {\partial \over \partial t} {\mathbf {a}} \end{aligned}$$
(13)

Matrices K, M and vector f are assembled from the element contributions given by

$$\begin{aligned} K_{ij}^e= & {} \int _{\Omega ^e} [N_i \left( {\mathbf {v}}^T+ \frac{s}{2}{\mathbf {h}}^T\right) {\pmb \nabla } N_j + {\pmb \nabla }^T N_i ({\mathbf {D}} + {1\over 2}{\mathbf {h}}{\mathbf {v}}^T){\pmb \nabla } N_j]d\Omega \nonumber \\&-\, {1\over 2} \int _{\Omega ^e} {\mathbf {h}}^T {\pmb \nabla } N_i {\pmb \nabla } ({\mathbf {D}} {\pmb \nabla } N_j)d\Omega \end{aligned}$$
(14)
$$\begin{aligned} M_{ij}^e= & {} \int _{\Omega ^e}\rho c N_i \left( N_j + {1\over 2}{\mathbf {h}}^T {\pmb \nabla } N_j\right) d\Omega ;\nonumber \\&f_i^e =\int _{\Omega ^e} [N_i + {1\over 2} {\mathbf {h}}^T{\pmb \nabla } N_i] Qd\Omega - \int _{\Gamma _q^e}N_i \bar{q}^{p} d\Gamma \end{aligned}$$
(15)

The FIC/FEM formulation presented above yields an additional diffusivity and an additional “pseudo” velocity given by \({1\over 2} {\mathbf {h}}{\mathbf {v}}^T \) and \(\frac{s}{2}{\mathbf {h}}\), respectively. Also the second integral of Eq. (14) vanishes for linear FEM approximations. The same happens with the second term of the first integral of \(f_i\) in Eq. (15) when \(N_i\) is linear and Q is constant. The evaluation of these integrals is mandatory in any other case.

This FIC/FEM formulation yields stabilized numerical solutions for the advection–diffusion-reaction equation for a wide range of the physical parameters.

For instance, FIC/FEM solutions for 1D and 2D steady-state advection–diffusion-absorption problems have been respectively obtained by Oñate et al. [21, 22] using a non-linear expression for the stabilization parameters. Nodally, exact FIC/FEM solutions for the 1D diffusion–absorption case and the Helmholz equation using a single (linear) stabilization parameter were reported by Felippa and Oñate [6] using a variational approach. Oñate, Miquel and Nadukandi [28] have recently presented a general FIC/FEM framework for accurately solving the steady-state and transient 1D advection–diffusion-reaction equation using two (linear) stabilization parameters.

Figure 3 shows FIC/FEM results for two advection–diffusion-absorption problems solved with 2-noded linear elements. Exact nodal values are found [21, 28].

Fig. 3
figure 3

1D advection–diffusion–absorption problem (\(Q=0\)). Exact and FIC–FEM results for a uniform mesh of eight 2-noded elements of length \(l^e\). a \(\gamma =1\), \(\omega =5\); b \(\gamma =2\), \(\omega =2\) \(\left( \gamma = \frac{\rho c u l^e}{2k}\right. \), \(\left. w = \frac{s(l^e)^2}{k}\right) \) [21, 28]

Figure 4 shows the FIC/FEM solution for two Helmholtz problems using 2-noded elements. Again nodally exact results are found [6, 28].

Fig. 4
figure 4

1D Helmholtz problem (\(Q=0\)). Exact and FIC–FEM results for a uniform mesh of eight 2-noded elements of length \(l^e\). a \(\gamma =0\), \(\omega =-5\); b \(\gamma =0\), \(\omega =-100\) \(\left( \gamma = \frac{\rho c u l^e}{2k}, w = \frac{s(l^e)^2}{k}\right) \) [6, 28]

A FIC/FEM technique for the transient diffusion equation

The solution of transient problems in mechanics using large time steps has been attempted by different researchers. One example, is the LATIN method proposed by Ladevèze et al. [34, 35]. This is a general nonincremental iterative non linear solution scheme for time-dependent problems in mechanics which works globally over the entire time-space domain.

Idelsohn et al. [36, 37] have proposed a Lagrangian numerical procedure for solving convective-diffusive transport and fluid-flow problems using large time steps.

The FIC approach can also be used for deriving numerical schemes for solving the transient diffusion problem with enhanced features regarding the stability and accuracy of the solution in time. The so-called FIC-time procedure can be summarized as follows. The starting point is the FIC governing equation in time for the standard diffusion problem written as

$$\begin{aligned} r + s_g \frac{\delta }{2} {\partial r \over \partial t} =0 \quad \hbox {with}\quad r: =\rho c {\partial \phi \over \partial t} - {\partial \over \partial x_j} \left( k {\partial \phi \over \partial x_j} \right) -Q =0 \end{aligned}$$
(16)

where \(\delta \) is a characteristic time parameter, as mentioned earlier. Typically \(\delta \) is chosen as a proportion of the time step chosen for the transient numerical solution.

Discretization of Eq. (16) using the Galerkin FEM yields a system of algebraic equations of the form

$$\begin{aligned} s_g \frac{\delta }{2} {\mathbf {C}} \ddot{\mathbf {a}} + \left( {\mathbf {C}}+s_g \frac{\delta }{2} {\mathbf {K}}\right) \dot{\mathbf {a}} + {\mathbf {K}}{\mathbf {a}}={\mathbf {f}} +s_g \frac{\delta }{2}\dot{\mathbf {f}} \end{aligned}$$
(17)

Equation (17) is the starting point for deriving a family of new FIC-time integration schemes for the transient diffusion equation. By adequately choosing the characteristic time parameter \(\delta \) and the sign parameter \(s_g\), the following time integration schemes with improved numerical features can be found [33]:

  • Stable explicit solution schemes allowing larger time steps.

  • Accurate implicit solution schemes allowing larger time steps.

In conclusion, the FIC-time procedure opens a range of possibilities for deriving new improved time integration schemes for solving transient diffusive transport problems with the FEM. The method is also applicable to the FEM solution of Lagrangian flows with larger time steps than using standard time integration schemes.

The FIC approach in fluid mechanics

The FIC equations for the balance of momentum in fluid mechanics are obtained by expressing the equilibrium of forces along each space direction in a domain of finite size finite. Following a procedure analogous to that explained in the previous section for the 1D advection–diffusion problem, the momentum balance equation along the ith space direction can be written as

$$\begin{aligned} \sum f_i d\Omega = {\partial \over \partial t} \int _\Omega \rho v_i d\Omega + \int _\Gamma (\rho v_i ) {\mathbf {v}}^T {\mathbf {n}}\, d\Gamma \quad i=1,n_d \end{aligned}$$
(18)

where the different terms in the right-hand-side have been defined earlier and \(f_i\) includes the forces due to the stresses acting on the boundary \(\Gamma \) of the balance domain \(\Omega \) and the body forces \(b_i\). Figure 5 shows a typical 2D FIC domain for the balance of momentum along the \(x_1\) direction. Similar domains are used for the other space directions.

Fig. 5
figure 5

Finite domain where balance of momentum is imposed along the horizontal direction

The next step in to express the values of the momentum and force terms at the corner points of the balance domain in terms of those at a reference point within the balance domain using higher order Taylor expansions in the space directions. Retaining second order terms in the expansions, yields the FIC momentum equations in fluid mechanics as [1, 12]

$$\begin{aligned} \bar{r}_{m_i} - \underline{{1\over 2} h_{ij}{\partial \bar{r}_{m_i} \over \partial x_j}}=0 \qquad i,j=1,n_d \end{aligned}$$
(19)

where for the standard Eulerian formulation in fluid mechanics [2, 3]

$$\begin{aligned} \bar{r}_{m_i} := \rho \left[ {\partial v_i \over \partial t}+{\partial \over \partial x_j}(v_i v_j)\right] - {\partial \sigma _{ij} \over \partial x_j}-b_i \end{aligned}$$
(20)

with \(\sigma _{ij} = s_{ij}-p \delta _{ij}\), where p is the pressure, \(\delta _{ij}\) is the Dirac delta and \(s_{ij}\) are the viscous deviatoric stresses related to the strain rates \(\varepsilon _{ij}\) and the velocities \(v_i\) as

$$\begin{aligned} s_{ij}=2\mu \left( \varepsilon _{ij} - \delta _{ij} {1\over 3} {\partial v_k \over \partial x_k}\right) \quad \hbox {where}\quad \varepsilon _{ij}={1\over 2} \left( {\partial v_i \over \partial x_j}+{\partial v_j \over \partial x_i}\right) \end{aligned}$$
(21)

Note that distance \(h_{12}\) is arbitrary when writing the balance of momentum along the \(x_1\) direction. The same applies for the distance \(h_{21}\) when deriving the balance equation along the \(x_2\) direction. Thus, in general, \(h_{12}\not = h_{21}\).

Fig. 6
figure 6

FIC domain where balance of mass is enforced

Mass balance equation

The FIC mass balance equation is obtained by invoking the balance of mass in the finite size domain of Fig. 6

$$\begin{aligned} \int _\Gamma \rho {\mathbf {v}}^T {\mathbf {n}} d\Gamma =0 \end{aligned}$$
(22)

Expanding the values of \(\rho v_i\) at the corner points in terms of the value at the corner point A gives the FIC mass balance equation as [1, 12]

$$\begin{aligned} \varepsilon _v -\underline{{1\over 2} h_j {\partial \varepsilon _v\over \partial x_j}}=0 \quad j=1,n_d\quad \hbox {with} \quad \varepsilon _v ={\partial v_i\over \partial x_i} \end{aligned}$$
(23)

A matrix form of the characteristic distances is not obtained in this case as Eq. (22) expresses the conservation of mass (which is a scalar quantity) in the domain ABCD of Fig. 6 with dimensions \(h_1\) and \(h_2\). Distances \(h_1\) and \(h_2\) are in general different from the \(h_{ij}\) defining the FIC domain where balance of momentum is enforced for each space direction. In practice it is typically assumed that \(h_1 = h_{11}\) and \(h_2 = h_{22}\) for simplicity. The advantage of choosing the \(h_i\) distances independently of the \(h_{ij}\) ones should be explored in the search of numerical schemes with enhanced properties for computational fluid mechanics.

Boundary conditions

The FIC Neumann boundary conditions are obtained by expressing the balance of momentum in a domain of finite size adjacent to a boundary \(\Gamma _t\) where the surface tractions \(t_i\) act. After some algebra we obtain [1, 12]

$$\begin{aligned} n_j \sigma _{ij} -t_i + \underline{{1\over 2} h_{ij} n_j r_{m_i}}=0 \quad \hbox {on }\Gamma _t \quad j=1,n_d, \quad \hbox {no sum in }i \end{aligned}$$
(24a)

In Eq. (24a) the \(h_{ij}\) distances define the domain where equilibrium of boundary tractions is established. The boundary condition on the Dirichlet boundary \(\Gamma _v\) is the standard one:

$$\begin{aligned} v_j - v_j^p =0 \quad \hbox {on }\,\Gamma _u \end{aligned}$$
(24b)

In the discretized problem the characteristic distances \(h_{ij}\) and \(h_{i}\) become of the order of the typical element dimension. The standard differential equations of momentum and mass balance in fluid mechanics are recovered by making these distances equal to zero.

Eqs. (19), (23) and (24) are the starting point for deriving stabilized FEM for solving the incompressible Navier-Stokes equations. The underlined FIC terms in Eqs. (19) and (24a) suffice for overcoming the numerical instabilities occurring for high Reynolds numbers, whereas the underlined terms in Eq. (23) take care of the eventual instabilities due to the incompressibility constraint.

The discretized system of finite element equations is obtained by interpolating the velocities and the pressure in terms of nodal values using a mixed FEM formulation and then applying the Galerkin method to the FIC governing equations.

An important feature of the FIC/FEM formulation is that it leads to a stabilized set of equations when using equal order FEM interpolations for the velocity and pressure variables [1, 12].

Applications to the FIC/FEM procedure in fluid mechanics

The FIC/FEM procedure has been successfully applied for solving the Navier-Stokes equations for incompressible flow problems using the standard Eulerian formulation presented above [12, 19, 38, 39]. A mixed FEM with a linear interpolation for the velocities and the pressure was used in both cases. FIC/FEM formulations for Stokes flows were reported in [26, 40]. Applications of the FIC/FEM technique to fluid-structure interaction (FSI) problems were reported in [14] (for Eulerian flows) and in [4144] (for Lagrangian flows). The FIC/FEM procedure has been also applied to viscous and inviscid compressible flows as reported in [79].

Oñate, Valls and García [23, 24] showed that the stabilization terms introduced by the FIC approach in the momentum equation in Eulerian flows provide enough stability for solving high Reynolds number flows with the FEM without the need of resorting to a turbulence model. This important feature of the FIC method has been recently extended and exploited by Cotela [4] and Cotela, Oñate and Rossi [5] for the FIC/FEM analysis of a range of incompressible turbulent flow problems.

Figure 7 presents a 3D simulation of unsteady incompressible flow around a cylinder at a Reynolds number of 10,000. The diameter of the cylinder is 2 units and its length is 8 units. The computation domain extends 15 units upstream, 60 units downstream, and 30 units in the cross flow direction (Fig. 7a). The boundary conditions consist of uniform inflow velocity set to 1.0, zero-normal-velocity and zero-shear-stress at the lateral boundaries, traction-free conditions at the outflow boundary and no-slip at the cylinder surface.

Fig. 7
figure 7

a Computational domain for 3D flow past a cylinder. b Details of the mesh used for the computations. (c1) Vorticity vector modulus w isosurfaces: \(w =0.1,0.2,0.3\); (c2) \(w =0.2\); (c3) Streamlines at time \(t=50\) [23]

The FIC/FEM computation used a structured mesh of some 5 millions linear tetrahedral elements. The thickness of the layer of elements around the cylinder is 0.001. The time step was set to 0.025 s. The time-averaged drag coefficient computed is 1.07 and compares well with the experimental value of 1.12. The Strouhal number computed is 2.02 and also agrees with experimental measurements.

Figures 7c1–2 show the isosurfaces of the vorticity vector modulus for three different vorticity values. Figure 7c3 shows streamlines behind the cylinder within the recirculation area. Details of this problem can be found in [23].

A particle finite element method via FIC

The FIC approach has also been used for deriving a Lagrangian Particle Finite Element Method (PFEM, http://www.cimne.com/pfem) that has proven to be useful for solving a variety of problems in fluid mechanics and fluid-structure interaction. The PFEM blends concepts from Lagrangian particle-based techniques and the FEM. The Lagrangian equations of motion for the fluid and solid domains that interact with each other are solved on a finite element mesh which is regenerated at each time step using the information from the nodes that are treated as virtual particles [41]. The physical parameters of the problem are transferred from the nodes to the elements and viceversa at each time step. For the numerical analysis of Lagrangian flows the infinitesimal form of the momentum equations is used. However, the FIC approach is required for stabilizing the mass conservationequation in the fluid, which allows using linear elements for interpolating the velocities and the pressure [41].

Fig. 8
figure 8

Study of breaking waves on the edge of a breakwater structure formed by concrete blocks using the particle finite element method (PFEM, http://www.cimne.com/pfem)

The good performance of the FIC/FEM formulation in terms of mass conservation and accuracy for analysis of Lagrangian flows and FSI problems are reported in [44].

Figures 8, 9, 10 and 11 show some examples of application of the PFEM to FSI problems. Figures 8 and 9 respectively show the study of the effect of waves impacting on a breakwater and the erosion and failure of a soil mass adjacent to the shore due to the action of the waves. Figure 10 shows the impact of a landslide on four houses. Finally, Fig. 11 displays the motion of cars and other objects and debrie particles passing over a vertical wall on a tsunami flow. Other applications of the FIC/FEM formulation are reported in [38, 4144].

Fig. 9
figure 9

PFEM analysis of the erosion in a soil mass next to the shore front due to sea waves and the subsequent falling into the sea of a lorry

Fig. 10
figure 10

PFEM simulation of a landslide falling on four houses

Fig. 11
figure 11

Dragging of cars and large and small objects and particles passing over a vertical wall in the Fukushima tsunami (Japan). a The actual problem. b Numerical results obtained with the PFEM

A FIC/FEM formulation for solid mechanics

Application of the FIC method to the equations of equilibrium of forces in solid mechanics leads to the following modified governing equations (for the static case)

$$\begin{aligned} r_{i}-\underline{{h_{ij}\over 2}{\partial r_i \over \partial x_j}} =0 \quad i,j=1,n_d \quad \hbox {with}\quad r_{i}:= {\partial \sigma _{ij}\over \partial x_j}+b_i \end{aligned}$$
(25)

The deviatoric stress-strain and the strain-displacement relationships have identical form to Eq. (21), respectively substituting the viscosity \(\mu \) by the shear modulus G and the velocities \(v_i\) by the displacements \(u_i\).

The FIC method can also be applied to derive a modified equation relating the pressure and the volumetric strain change over a finite size domain as [16, 18]

$$\begin{aligned} \left( {1\over K} p - {\varepsilon }_{v}\right) - \underline{\frac{h_j}{2}{\partial \over \partial x_j} \left( {1\over K} p - {\varepsilon }_{v}\right) }=0\, ,\quad j=1,n_d \end{aligned}$$
(26)

where K is the volumetric elastic modulus and \(\varepsilon _v={\partial u_i\over \partial x_i}\). For an incompressible material \(K\rightarrow \infty \) and in this case Eq. (26) recovers a form analogous to that of the stabilized mass balance equation in fluid mechanics Eq. (23).

The underlined terms in Eqs. (25) and (26) result from the FIC assumptions and, as usual, \(h_{ij}\) and \(h_k\) are the characteristic length parameters. The governing equations are completed with the adequate boundary conditions. Once more, for consistency, the Neumann boundary conditions should incorporate a stabilization term identical (with a minus sign in front of the FIC term) to that of Eq. (24b) [16, 18].

The FIC formulation in conjunction with the FEM has been successfully applied to the static and dynamic solution of quasi-incompressible and full incompressible solids using 3-noded triangles and 4-noded quadrilaterals with equal order interpolation for the displacements and the pressure [16, 18, 45].

Error estimation and mesh adaption procedures via FIC

The FIC approach can also be used for deriving a procedure for estimating the error in the numerical solution. The FIC contributions to the discretized form of the modified governing equations can be interpreted as a residual error term that depends on the element size and that tends to zero for very fine meshes and, indeed, it vanishes for the exact solution.

The application of the FIC technique to the estimation of the numerical error can be viewed as a particular class of the so-called residual-based error estimation procedures widely used in computational mechanics [46]. The fact that the residual error estimation terms emerge naturally in the FIC formulation is a distinct feature of the method.

Oñate et al. [20] have used the FIC method for formulating a residual-based error estimation technique and the corresponding mesh adaption scheme for analysis of incompressible flows with the FEM.

Concluding remarks

The acceptance that the space-time domain where the balance equations are established in mechanics has a finite size leads to a modified set of FIC governing differential equations that incorporate the space and time dimensions of the balance domain. The FIC governing equations can be taken as the starting point for deriving a wide range of numerical schemes with improved features in terms of stability and accuracy for solving steady-state and transient problems of advective–diffusive-reactive transport, fluid dynamics and incompressible solids, among many others.

References

  1. Oñate E. Derivation of stabilized equations for numerical solution of advective–diffusive transport and fluid flow problems. Comput Methods Appl Mech Eng. 1998;151(1–2):233–65. doi:10.1016/S0045-7825(97)00119-9.

    Article  MathSciNet  MATH  Google Scholar 

  2. Donea J, Huerta A. Finite element methods for flow problems. Chichester: Wiley; 2003. p. 350. doi:10.1002/0470013826. http://doi.wiley.com/10.1002/0470013826.

  3. Zienkiewicz OC, Taylor RL, Nithiarasu P. The finite element method for fluid dynamics. 6th ed. Oxford: Elsiever Butterworth-Heinemann; 2005.

    MATH  Google Scholar 

  4. Cotela J. Applications of turbulence modeling in civil engineering. Barcelona: Technical University of Catalonia; 2016.

    Google Scholar 

  5. Cotela J, Onate E, Rossi R. A FIC/FEM formulation for analysis of turbulent flows. Research report PI413. Barcelona: CIMNE; 2016.

  6. Felippa CA, Oñate E. Nodally exact Ritz discretizations of 1D diffusion–absorption and Helmholtz equations by variational FIC and modified equation methods. Comput Mech. 2007;39(2):91–111. doi:10.1007/s00466-005-0011-z.

    Article  MathSciNet  MATH  Google Scholar 

  7. Kouhi M, Oñate E. An implicit stabilized finite element method for the compressible Navier-Stokes equations using finite calculus. Comput Mech. 2015;56(1):113–29. doi:10.1007/s00466-015-1161-2.

    Article  MathSciNet  MATH  Google Scholar 

  8. Kouhi M, Oñate E. A stabilized finite element formulation for high-speed inviscid compressible flows using finite calculus. Int J Numer Methods Fluids. 2014;74(12):872–97. doi:10.1002/fld.3877.

    Article  MathSciNet  Google Scholar 

  9. Kouhi M, Oñate E, Mavriplis D. Adjoint-based adaptive finite element method for the compressible Euler equations using finite calculus. Aerosp Sci Technol. 2015;46:422–35. doi:10.1016/j.ast.2015.08.008.

    Article  Google Scholar 

  10. Oñate E, García J, Idelsohn S. An alpha-adaptive approach for stabilized finite element solution of advective–diffusive problems with sharp gradients. Stud Appl Mech. 1998;47:309–23. doi:10.1016/S0922-5382(98)80017-2.

    Article  MathSciNet  Google Scholar 

  11. Oñate E, Manzan M. A general procedure for deriving stabilized space-time finite element methods for advective–diffusive problems. Int J Num Meth Fluids. 1999;31:203–21.

    Article  MathSciNet  MATH  Google Scholar 

  12. Oñate E. A stabilized finite element method for incompressible viscous flows using a finite increment calculus formulation. Comput Methods Appl Mech Eng. 2000;182(3–4):355–70. doi:10.1016/S0045-7825(99)00198-X.

    Article  MathSciNet  MATH  Google Scholar 

  13. Oñate E, Sacco C, Idelsohn S. A finite point method for incompressible flow problems. Comput Vis Sci. 2000;3(1–2):67–75. doi:10.1007/s007910050053.

    Article  MATH  Google Scholar 

  14. Oñate E, García J. A finite element method for fluid-structure interaction with surface waves using a finite calculus formulation. Compt Methods Appl Mech Eng. 2001;191(6–7):635–60. doi:10.1016/S0045-7825(01)00306-1.

    Article  MATH  Google Scholar 

  15. Oñate E. Multiscale computational analysis in mechanics using finite calculus: an introduction. Comput Methods Appl Mech Eng. 2003;192(28–30):3043–59. doi:10.1016/S0045-7825(03)00340-2.

    Article  MathSciNet  MATH  Google Scholar 

  16. Oñate E, Taylor RL, Zienkiewicz OC, Rojek J. A residual correction method based on finite calculus. Eng Comput. 2003;20(5/6):629–58. doi:10.1108/02644400310488790.

    Article  MATH  Google Scholar 

  17. Oñate E. Possibilities of finite calculus in computational mechanics. Int J Num Meth Eng. 2004;60(1):255–81.

    Article  MathSciNet  MATH  Google Scholar 

  18. Oñate E, Rojek J, Taylor RL, Zienkiewicz OC. Finite calculus formulation for incompressble solids using linear triangles and tetrahedra. Int J Numer Methods Eng. 2004;59:1473–500.

    Article  MATH  Google Scholar 

  19. Oñate E, García J, Idelsohn SR, Pin FD. Finite calculus formulations for finite element analysis of incompressible flows. Eulerian, ALE and Lagrangian approaches. Comput Methods Appl Mech Eng. 2006;195(23–24):3001–37. doi:10.1016/j.cma.2004.10.016.

    Article  MathSciNet  MATH  Google Scholar 

  20. Oñate E, Arteaga J, García J, Flores R. Error estimation and mesh adaptivity in incompressible viscous flows using a residual power approach. Comput Methods Appl Mech Eng. 2006;195(4–6):339–62. doi:10.1016/j.cma.2004.07.054.

    Article  MathSciNet  MATH  Google Scholar 

  21. Oñate E, Miquel J, Hauke G. Stabilized formulation for the advection–diffusion-absorption equation using finite calculus and linear finite elements. Comput Methods Appl Mech Eng. 2006;195(33–36):3926–46. doi:10.1016/j.cma.2005.07.020.

    Article  MathSciNet  MATH  Google Scholar 

  22. Oñate E, Zárate F, Idelsohn SR. Finite element formulation for convective–diffusive problems with sharp gradients using finite calculus. Comput Methods Appl Mech Eng. 2006;195(13–16):1793–825. doi:10.1016/j.cma.2005.05.036.

    Article  MathSciNet  MATH  Google Scholar 

  23. Oñate E, Valls A, García J. Computation of turbulent flows using a finite calculus-finite element formulation. Int J Numer Methods Fluids. 2007;54(6–8):609–37. doi:10.1002/fld.1476.

    Article  MathSciNet  MATH  Google Scholar 

  24. Oñate E, Valls A, García J. Modeling incompressible flows at low and high Reynolds numbers via a finite calculus-finite element approach. J Comput Phys. 2007;224(1):332–51.

    Article  MathSciNet  MATH  Google Scholar 

  25. Oñate E, Celigueta MA, Idelsohn SR, Salazar F, Suárez B. Possibilities of the particle finite element method for fluid-soil-structure interaction problems. Comput Mech. 2011;48(3):307–18. doi:10.1007/s00466-011-0617-2.

    Article  MathSciNet  MATH  Google Scholar 

  26. Oñate E, Idelsohn SR, Felippa CA. Consistent pressure Laplacian stabilization for incompressible continua via higher-order finite calculus. Int J Numer Methods Eng. 2011;87(1–5):171–95. doi:10.1002/nme.3021.

    Article  MathSciNet  MATH  Google Scholar 

  27. Oñate E, Celigueta MA, Latorre S, Casas G, Rossi R, Rojek J. Lagrangian analysis of multiscale particulate flows with the particle finite element method. Comput Part Mech. 2014;1(1):85–102. doi:10.1007/s40571-014-0012-9.

    Article  Google Scholar 

  28. Oñate E, Miquel J, Nadukandi P. An accurate FIC–FEM formulation for the 1D advection–diffusion-reaction equation. Comput Methods Appl Mech Eng. 2016;298:373–406. doi:10.1016/j.cma.2015.09.022.

    Article  MathSciNet  Google Scholar 

  29. Oñate E, Idelsohn SR, Zienkiewicz OC, Taylor RL. A finite point method in computational mechanics. Applications to convective transport and fluid flow. Int J Numer Methods Eng. 1996;39(22):3839–66.

    Article  MathSciNet  MATH  Google Scholar 

  30. Oñate E, Idelsohn S, Zienkiewicz OC, Taylor RL, Sacco C. A stabilized finite point method for analysis of fluid mechanics problems. Comput Methods Appl Mech Eng. 1996;139(1–4):315–46. doi:10.1016/S0045-7825(96)01088-2.

    Article  MathSciNet  MATH  Google Scholar 

  31. Oñate E, Idelsohn S. A mesh-free finite point method for advective–diffusive transport and fluid flow problems. Comput Mech. 1998;21(4–5):283–92. doi:10.1007/s004660050304.

    MathSciNet  MATH  Google Scholar 

  32. Oñate E, García J, Idelsohn S. Computation of the stabilization parameter for the finite element solution of advective–diffusive problems. Int J Numer Methods Fluids. 1997;25(12):1385–407.

    Article  MATH  Google Scholar 

  33. Oñate E, Idelsohn SR, Becker P. A FIC-time approach for deriving enhanced time integration schemes for the transient diffusive equation. Research Report PI414. Barcelona: CIMNE; 2016.

  34. Ladevèze P. Nonlinear computational structural mechanics. Mechanical engineering series. New York: Springer; 1999. doi:10.1007/978-1-4612-1432-8. http://link.springer.com/10.1007/978-1-4612-1432-8

  35. Ladevèze P, Passieux J-C, Néron D. The LATIN multiscale computational method and the proper generalized decomposition. Comput Methods Appl Mech Eng. 2010;199(21–22):1287–96. doi:10.1016/j.cma.2009.06.023.

    Article  MathSciNet  MATH  Google Scholar 

  36. Idelsohn S, Nigro N, Limache A, Oñate E. Large time-step explicit integration method for solving problems with dominant convection. Compt Methods Appl Mech Eng. 2012;217–220:168–85. doi:10.1016/j.cma.2011.12.008.

    Article  MathSciNet  MATH  Google Scholar 

  37. Idelsohn SR, Marti J, Becker P, Oñate E. Analysis of multifluid flows with large time steps using the particle finite element method. Int J Numer Methods Fluids. 2014;75(9):621–44. doi:10.1002/fld.3908.

    Article  MathSciNet  Google Scholar 

  38. Oñate E, Rojek J, Chiumenti M, Idelsohn SR, Pin FD, Aubry R. Advances in stabilized finite element and particle methods for bulk forming processes. Comput Methods Appl Mech Eng. 2006;195:6750–77. doi:10.1016/j.cma.2004.10.018.

    Article  MathSciNet  MATH  Google Scholar 

  39. García J, Oñate E. An unstructured finite element solver for ship hydrodynamics problems. J Appl Mech. 2003;70(1):18. doi:10.1115/1.1530631.

    Article  MATH  Google Scholar 

  40. Oñate E, Nadukandi P, Idelsohn SR, García J, Felippa C. A family of residual-based stabilized finite element methods for stokes flows. Int J Numer Methods Fluids. 2011;65(1–3):106–34. doi:10.1002/fld.2468.

    Article  MathSciNet  MATH  Google Scholar 

  41. Oñate E, Idelsohn SR, Del Pin F, Aubry R. The particle finite element method: an overview. Int J Comput Methods. 2004;01(02):267–307. doi:10.1142/S0219876204000204.

    Article  MATH  Google Scholar 

  42. Oñate E, Idelsohn SR, Celigueta MA, Rossi R. Advances in the particle finite element method for the analysis of fluid-multibody interaction and bed erosion in free surface flows. Comput Meth Appl Mech Eng. 2008;197(19–20):1777–800. doi:10.1016/j.cma.2007.06.005.

    Article  MathSciNet  MATH  Google Scholar 

  43. Oñate E, Franci A, Carbonell JM. A particle finite element method for analysis of industrial forming processes. Comput Mech. 2014;54(1):85–107. doi:10.1007/s00466-014-1016-2.

    Article  MathSciNet  MATH  Google Scholar 

  44. Oñate E, Franci A, Carbonell JM. Lagrangian formulation for finite element analysis of quasi-incompressible fluids with reduced mass losses. Int J Numer Methods Fluids. 2014;74(10):699–731. doi:10.1002/fld.3870.

    Article  MathSciNet  Google Scholar 

  45. Rojek J, Oñate E, Taylor RL. CBS-based stabilization in explicit solid dynamics. Int J Numer Methods Eng. 2006;66:1547–68. doi:10.1002/nme.1689.

    Article  MathSciNet  MATH  Google Scholar 

  46. Ladevèze P, Pelle JP. Mastering calculations in linear and nonlinear mechanics. Mechanical engineering series. New York: Springer; 2005. doi:10.1007/b138705. http://link.springer.com/10.1007/b138705

Download references

Acknowledgements

E. Oñate thanks Profs. S.R. Idelsohn, C. Felippa and J. Miquel and Dr. P. Nadukandi for many useful comments.

Dedicated to Prof. Pierre Ladevèze on the occasion of his 70th birthday.

Competing interests

The author declares no competing interests.

Author information

Authors and Affiliations

Authors

Corresponding author

Correspondence to Oñate Eugenio.

Rights and permissions

Open Access This article is distributed under the terms of the Creative Commons Attribution 4.0 International License (http://creativecommons.org/licenses/by/4.0/), which permits unrestricted use, distribution, and reproduction in any medium, provided you give appropriate credit to the original author(s) and the source, provide a link to the Creative Commons license, and indicate if changes were made.

Reprints and permissions

About this article

Check for updates. Verify currency and authenticity via CrossMark

Cite this article

Eugenio, O. Finite increment calculus (FIC): a framework for deriving enhanced computational methods in mechanics. Adv. Model. and Simul. in Eng. Sci. 3, 14 (2016). https://doi.org/10.1186/s40323-016-0065-9

Download citation

  • Received:

  • Accepted:

  • Published:

  • DOI: https://doi.org/10.1186/s40323-016-0065-9

Keywords