Abstract
Continued advances in computational power and methods have enabled image-based biomechanical modeling to become an important tool in basic science, diagnostic and therapeutic medicine, and medical device design. One of the many challenges of this approach, however, is identification of a stress-free reference configuration based on in vivo images of loaded and often prestrained or residually stressed soft tissues and organs. Fortunately, iterative methods have been proposed to solve this inverse problem, among them Sellier’s method. This method is particularly appealing because it is easy to implement, convergences reasonably fast, and can be coupled to nearly any finite element package. By means of several practical examples, however, we demonstrate that in its original formulation Sellier’s method is not optimally fast and may not converge for problems with large deformations. Fortunately, we can also show that a simple, inexpensive augmentation of Sellier’s method based on Aitken’s delta-squared process can not only ensure convergence but also significantly accelerate the method.
Keywords: Inverse Methods, Fixed-Point Methods, Aitken’s Delta-Squared Process, Stress-free Reference Configuration, Image-Based Biomechanical Modeling
1. Introduction
Image-based biomechanical modeling has become an important tool in basic science, diagnostic and therapeutic medicine, and medical device design (Baillargeon et al., 2015; Rausch et al., 2016a; Bosmans et al., 2016). Ever improving image resolution and computational power increasingly enable models with greater detail. One key challenge remains, however. Tissues and organs, in vivo, are often prestrained and residually stressed in addition to experiencing time-varying in vivo loads (Han and Fung, 1991; Bellini et al., 2014; Tepole et al., 2016). Thus, the stress-free reference configuration is, in general, not readily accessible from in vivo images (Weisbecker et al., 2014).
Fortunately, when the deformed configuration and its corresponding boundary conditions are known, for a given constitutive relation, the stress-free reference configuration can be estimated using inverse methods. These methods can be broadly classified either as direct methods, in which the inverse motion from the deformed configuration to the stress-free reference configuration is solved (Govindjee and Mihalic, 1996), or as iterative methods, which identify the stress-free reference configuration by employing multiple forward calculations (Sellier, 2011; Bols et al., 2013; Maas et al., 2016b). One such iterative method is a fixed-point method introduced by Sellier (2011) for general elasto-static problems and reintroduced by Bols et al. (2013) and, in extended form, by Riveros et al. (2013) for problems in cardiovascular biomechanics. Sellier’s method has since been applied successfully to a number of image-based biomechanical modeling problems, owing its success largely to algorithmic simplicity, the relative ease with which it can be coupled to established finite element software packages, and applicability to a wide range of material models (Wittek et al., 2013; Genet et al., 2015).
In the first iteration, Sellier applies the measured in vivo tractions (such as blood pressure or intraocular pressure) to a guessed initial reference configuration with coordinates X1 to compute the first updated deformed configuration with coordinates x1, see Figure 1. For lack of better alternatives, the initial reference configuration is usually chosen to be the measured in vivo configuration with coordinates x*. Subsequently, the reference configuration is updated by subtracting the per node displacement vector between the updated deformed configuration and the target in vivo configuration, Rk = xk − x*, viz. Xk+1 = Xk – αRk (see Algorithm 1, where Sellier let α = 1). This iterative procedure is then repeated until a required error tolerance ϵ is reached between the updated deformed configuration and the target in vivo configuration.
Fig. 1.
Illustration of Sellier’s iterative method for identifying a stress-free reference configuration in biomechanical boundary value problems. See also Algorithm 1.
Algorithm 1.
Sellier’s Inverse Method (with α = 1)
1: | initialize X1 ← x* |
2: | set k = 0 |
3: | while max (||Rk||) ≥ ϵ do |
4: | update counter, k ← k + 1 |
5: | solve forward problem, xk = ϕ(Xk) |
6: | calculate nodal error vector, Rk = xk − x* |
7: | update reference vector, Xk+1 = Xk − αRk |
8: | end while |
9: | stress-free reference configuration, X* = Xk |
One of the advantages of Sellier’s method is that any finite element package can be used to solve the forward problem, the only requirement being that the package can output nodal locations of the updated deformed configuration. A simple wrapper can then read the nodal locations, calculate the nodal displacement vector, update the reference configuration, and initiate the next forward calculation.
In their original manuscripts Sellier, Bols et al., and Riveros et al. assumed α = 1 (see Algorithm 1). Here, we show that α = 1 is not necessarily the best choice. Furthermore, we have previously combined Sellier’s method with Aitken’s delta-squared process and show here that by doing so Sellier’s method can be considerably accelerated at virtually no cost (Genet et al., 2015).
2. Methods
In all subsequent examples we assume that the mechanical behavior of soft tissue can be well approximated using a hyperelastic framework for appropriate conditions of interest (Martins et al., 2006). Furthermore, we specifically describe the material behavior using an anisotropic Fung-type strain energy function with an isotropic neo-Hookean component and n embedded fiber families (Holzapfel et al., 2000; Rausch et al., 2016b; Caulk et al., 2016). The isochoric component of the strain energy function, , thus reads (Rausch and Kuhl, 2014)
(1) |
where is the first invariant of the isochoric right Cauchy-Green tensor, , and are the squares of the fiber stretches of each fiber family, , with Mi the unit fiber orientation vectors. In addition, we constrain the material to behave quasi-incompressibly by penalizing the volumetric material response with a bulk modulus κ >> μ in the volumetric term , where J = detF (Weiss et al., 1996).
Also, we solve all forward problems employing the open-source finite element packages FEBio (www.febio.org) and use Matlab for all auxiliary tasks (Maas et al., 2012).
We begin our analysis with a canonical problem inspired by our recent histomechanical study of occlusive venous thrombus in mice. Given the in vivo measured length of a nearly cylindrical thrombus sample and venous blood pressure p (length: 4mm, diameter: 1.2mm, load: 10–30mmHg), we aim to determine the thrombus’ stress-free reference configuration. To simplify the problem, we reduce the geometry to a quarter cylinder with a traction-free radial surface plus tractions due to venous blood pressure on the proximal and distal surfaces. We further discretize this simplified geometry with 384 trilinear hexahedral elements and employ the hyperelastic framework to model the thrombus as a quasi-incompressible, neo-Hookean material with a shear modulus based on recent measurements in our laboratory (Lee et al., 2015) (see Equation (1) with for the strain energy function of a quasi-incompressible neo-Hookean material).
To explore the influence of α (augmentation parameter), ϵ (prescribed tolerance), and the magnitude of the loading that yields a finite deformation on the convergence of Sellier’s method, we apply Algorithm 1 to above problem for varying α, ϵ = 0.01mm, 0.001mm, 0.0001mm, and p = 10, 20, 30mmHg.
Next, we augment Sellier’s method by dynamically adapting α according to Aitken’s delta-squared process, which has previously been proven an efficient acceleration method for fluid-structure interaction problems and problems in nonlinear solid mechanics (Küttler and Wall, 2008; Genet et al., 2014), and which we have combined with Sellier’s method previously (Genet et al., 2015). Thus, in Algorithm 1, we add a step after calculating the nodal displacement vector, in which we update α according to
(2) |
see Algorithm 2. For the augmented method, we repeat the same sensitivity analysis as above.
In our second example, we explore Sellier’s method as well as our augmented method via a practical, yet, simple example from our laboratory. Specifically, we apply Sellier’s method to the quasi-static boundary value problem of a pressurized, axially prestretched healthy mouse arterial segment that we recently tested in our laboratory (and thus enables model validation). Albeit technically not an inverse problem, since the stress-free reference configuration is known, we imagine, for argument sake, that in addition to the material parameters only the in vivo target configuration as well as the luminal pressure and the axial prestretch are known. We model the arterial segment as a perfect quarter cylinder (length: 3.80mm, inner diameter: 0.57mm, wall thickness: 45.2μm, load: 80mmHg, axial prestretch: 1.77), discretized with 3072 trilinear hexahedral elements, and assume that the material is well approximated using the hyperelastic framework (see Equation (1) with n = 4). Here, we limit our analysis to the effect of α only (ϵ = 0.01mm).
In our third example, we apply Sellier’s method as well as the augmented method to a problem in heart valve mechanics taken from Rausch et al. (2011). In this example, the anterior ovine mitral valve, reconstructed from in vivo marker data, is exposed to systolic left ventricular pressure (100mmHg, also measured in vivo) and isotropic prestrain (30%) (Rausch et al., 2013; Amini et al., 2012). The leaflet is modeled as a transversely isotropic, thin, collagenous membrane and discretized with 1920 quadratic triangular elements. The material behavior is, again, approximated using the strain energy function in Equation (1). Note, only one fiber family is modeled in this example (n = 1) and ϵ = 0.01mm. In addition to a traction boundary condition on the ventricularis (the ventricular side of the leaflet), Dirichlet boundary conditions are applied to the external boundary of the leaflet as derived from the marker data. Neo-Hookean, 1D elements approximate the behavior of the chordae tendinae that emanate from the papillary muscles and insert in the belly regions of the leaflet. For more details see (Rausch et al., 2013).
Last, we apply Sellier’s method and the augmented method to an actual inverse problem from our laboratory. We derive the geometry of a murine aortic dissection from a combined in vivo (ultrasound) and in vitro (optical coherence tomography) imaging approach. At the time of imaging, the dissected aortic segmented was axially prestretched and subjected to an intraluminal pressure (length: 7.82mm, load: 80mmHg, axial prestretch: 1.50). For the present analysis we, again, assume that we can describe the aortic material behavior using the strain energy function in Equation (1) with n = 4. In contrast to the dissected aortic wall, we model the intramural thrombus as neo-Hookean. We assume the thrombus, like the aortic wall, is quasi-incompressible. Further, we spatially discretize the dissected aortic wall segment and thrombus complex with 141,661 10-node, quadratic, tetrahedral elements (Maas et al., 2016a) and solve the forward problem using FEBio, as above. As opposed to the previous problem, however, we do not perform a sensitivity analysis. Instead, based on findings in Figure 2, we applied each, Sellier’s method and the augmented method, for α = 0.5 and α = 1.0 (ϵ = 0.1mm). All examples with key features are summarized in Table 1.
Fig. 2.
For Sellier’s method the number of iterations to convergence strongly depends on a and is always larger than or equal to the number of iterations necessary for our augmented method. Furthermore, the augmented method is virtually independent of a and shows a larger convergence radius.
Table 1:
Summary of all investigated examples with key features.
Example | α [–] | ϵ [mm] | Fibers [#] | Load [mmHg] |
---|---|---|---|---|
| ||||
Venous Thrombus | 0.1 – 1.9 | 0.0001,0.001,0.01 | 0 | p=10,20,30 |
Aortic Segment | 0.1 – 1.0 | 0.01 | 4 | p=80 |
Mitral Valve Leaflet | 0.1 – 1.0 | 0.01 | 1 | p=100 |
Aortic Dissection | 0.5, 1.0 | 0.1 | 4 | p=80 |
Algorithm 2.
Augmented Sellier’s Inverse Method
1: | initialize X1 ← x* |
2: | set k = 0 |
3: | while max (||Rk||) ≥ ϵ do |
4: | update counter, k ← k+ 1 |
5: | solve forward problem, xk = ϕ(Xk) |
6: | calculate nodal error vector, Rk = xk − x* |
7: | if k > 1 then |
8: | update alpha, |
9: | end if |
10: | update reference vector, Xk+1 = Xk − αRk |
11: | end while |
12: | stress-free reference configuration, X* = Xk |
3. Results
Figure 2A illustrates the convergence behavior of Sellier’s method and our augmented method for our first example as a function of α (ϵ = 0.01mm and p = 30mmHg). First, we find that in Sellier’s original formulation, the number of iterations necessary to reach convergence varies significantly with α, with a minimum at α = 1.1. Second, we find that the augmented method converges almost independently of the initial value of α and converges faster than Sellier’s method for all values of a except for α = 1.1, where both methods converge equally fast. Last, we find that the convergence radius for Sellier’s method is pα ≤ 1.7, whereas the augmented method converges also for values larger than 1.7 (data not shown).
Not surprisingly, we also find that the number of iterations increases as we tighten the convergence criterion. Moreover, the number of iterations increases with increasing load and thus deformation. Interestingly, for both methods, the optimal a as well as the convergence radius pa are invariant to ϵ and p, at least for the tested values. Also, the augmented method always convergences faster than Sellier’s method except for the optimal α, where Sellier’s method and the augmented method convergence almost equally fast (with the augmented method needing one less iterations for ϵ = 0.001mm and ϵ = 0.0001mm).
The findings from our second example are summarized in Figure 2B. Confirming the results of the previous example, we find that in Sellier’s original formulation the number of iterations necessary to reach convergence varies significantly with α, with the smallest number of iterations at α = 0.6, 0.7. For α = 1, however, the method fails to converge, again, demonstrating a limited convergence radius. In accordance with the previous example, we further find that our augmented method is virtually insensitive to the choice of α and always converges faster than Sellier’s original formulation, albeit, not significantly for α = 0.6, 0.7. Additionally, our method converges for α = 1, demonstrating, again, a larger convergence radius.
Our third example confirms most findings of the previous two examples, see Figure 2C. Our augmented method results in faster convergence than Sellier’s method, whose convergence strongly depends on α. While Sellier’s method converges only for values of α ≤ 1, our augmented method convergences for values of α < 1 and α > 1. Note that the qualitative behavior of the α-dependence of Sellier’s method is different from the previous two examples in that the number of iterations appears to converge asymptotically toward the minimum.
Last, applied to the real-world inverse analysis problem of the prestretched and pressurized aortic dissection (Figure 3A), for α = 0.5, Sellier’s method converges in five iterations, while our augmented method converges in four iterations; for α = 1.0, Sellier’s method fails to converge, while our augmented method converges in five iterations. Thus, here again, our method converges faster than Sellier’s method and shows a larger convergence radius. Figure 3B shows the updated deformed configurations (k = 1…4) for our augmented method with α = 0.5 and demonstrates convergence of the updated deformed configuration toward the target in vivo configuration.
Fig. 3.
(A) Loaded in vivo geometry of a murine aortic dissection derived from in vivo ultrasound and in vitro optical coherence tomography with (1) aortic wall, (2) aortic lumen, (3) intramural thrombus, and (4) false lumen. (B) Convergence of the updated deformed configuration (k = 1, …, 4) for our augmented method (a = 0.5), where convergence occurred at iteration k = 4.
4. Discussion
Sellier’s method is a simple, yet efficient method for the inverse identification of a stress-free reference configuration as usually required for image-based biomechanical analyses. However, both Sellier, in the original work, as well as Bols et al. and Riveros et al., who reintroduced Sellier’s method specifically for biomechanical problems, assumed α = 1.
In four practical examples we demonstrate that Sellier’s method with α = 1 may result in suboptimal convergence rates and in some examples may fail to converge altogether. Thus, α = 1 need not be the optimal choice for Sellier’s method. We also find that the optimal α is problem dependent without means of a priori determination. Our augmented method may mitigate these shortcomings. We were able to demonstrate that dynamically adapting α via Aitken’s delta-squared process increases the convergence rate of Sellier’s method almost independently of the initially prescribed value of α and increases the convergence radius (Aitken, 1950).
An approach based on Sellier’s method, with material orientation vectors defined in the loaded in vivo configuration as opposed to the unloaded reference configuration (as in our case), has previously been applied successfully to problems in arterial mechanics (Riveros et al., 2013; Trabelsi et al., 2015). Although these authors did not report any issues of slow convergence or divergence when using α = 1, it is not possible to infer whether the convergence was less than optimal due to the lack of a systemic sensitivity analysis on α. It is possible, of course, that α = 1 happened to be close to the optimal value in these particular cases. Because optimal values appear to be problem specific, however, there is a need for caution unless using an objective method such as the augmentation suggested herein. Finally, to ensure that slow convergence rates and divergence with Sellier’s method (as reported in here) were not related to our treatment of the material orientations vectors, we repeated the second example with an isotropic neo-Hookean material model (not shown) and did not find significant changes in performance in Sellier’s method or our augmented method.
As noted in the introduction, inverse methods, such as Sellier’s method, require knowledge of the tissue’s material properties or at least assumptions about the tissue’s behavior. In most cases, especially for problems derived from in vivo data, such information is not readily available. However, it is important to note that Sellier’s method, and by extension the method described in here, can be integrated into a larger inverse framework, where not only the stress-free reference configuration is approximated, but also, based on image-based geometric data and measured in vivo loads, the material parameters.
In conclusion, augmenting Sellier’s method may guarantee convergence and significantly accelerates convergence and thus provides significant time savings for large problems. Hence, given that our augmentation comes at virtually no cost and requires almost no additional effort for implementation, biomechanists considering Sellier’s method should consider the augmentation proposed in this work.
Acknowledgment
This work was funded, in part, by NIH grants R01 HL086418, U01 HL116323, and T32 HL007974. We also thank Dr. Matthew R. Bersi and Dr. Paolo Di Achille for providing data for some of the examples in this manuscript.
Footnotes
Conflict of Interest
The authors declared that there are no conflicts of interest.
References
- Aitken AC, 1950. On the iterative solution of a system of linear equations. Proceedings of the Royal Society of Edinburgh. Section A. Mathematical and Physical Sciences 63 (01), 52–60. [Google Scholar]
- Amini R, Eckert CE, Koomalsingh K, McGarvey J, Minakawa M, Gorman JH, Gorman RC, Sacks MS, 2012. On the in vivo deformation of the mitral valve anterior leaflet: effects of annular geometry and referential configuration. Annals of Biomedical Engineering 40 (7), 1455–1467. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Baillargeon B, Costa I, Leach JR, Lee LC, Genet M, Toutain A, Wenk JF, Rausch MK, Rebelo N, Acevedo-Bolton G, et al. , 2015. Human cardiac function simulator for the optimal design of a novel annuloplasty ring with a sub-valvular element for correction of ischemic mitral regurgitation. Cardiovascular Engineering and Technology 6 (2), 105–116. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Bellini C, Ferruzzi J, Roccabianca S, Di Martino E, Humphrey J, 2014. A microstructurally motivated model of arterial wall mechanics with mechanobiological implications. Annals of Biomedical Engineering 42 (3), 488–502. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Bols J, Degroote J, Trachet B, Verhegghe B, Segers P, Vierendeels J, 2013. A computational method to assess the in vivo stresses and unloaded configuration of patient-specific blood vessels. Journal of Computational and Applied Mathematics 246, 10–17. [Google Scholar]
- Bosmans B, Famaey N, Verhoelst E, Bosmans J, Vander Sloten J, 2016. A validated methodology for patient specific computational modeling of self-expandable transcatheter aortic valve implantation. Journal of Biomechanics 49 (13), 2824–2830. [DOI] [PubMed] [Google Scholar]
- Caulk AW, Dixon JB, Gleason RL Jr, 2016. A lumped parameter model of mechanically mediated acute and long-term adaptations of contractility and geometry in lymphatics for characterization of lymphedema. Biomechanics and Modeling in Mechanobiology, 1–18. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Genet M, Marcin L, Ladeveze P, 2014. On structural computations until fracture based on an anisotropic and unilateral damage theory. International Journal of Damage Mechanics 23 (4), 483–506. [Google Scholar]
- Genet M, Rausch M, Lee L, Choy S, Zhao X, Kassab G, Kozerke S, Guccione J, Kuhl E, 2015. Heterogeneous growth-induced prestrain in the heart. Journal of Biomechanics 48 (10), 2080–2089. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Govindjee S, Mihalic PA, 1996. Computational methods for inverse finite elastostatics. Computer Methods in Applied Mechanics and Engineering 136 (1), 47–57. [Google Scholar]
- Han H, Fung Y, 1991. Residual strains in porcine and canine trachea. Journal of Biomechanics 24 (5), 307–315. [DOI] [PubMed] [Google Scholar]
- Holzapfel GA, Gasser TC, Ogden RW, 2000. A new constitutive framework for arterial wall mechanics and a comparative study of material models. Journal of Elasticity and the Physical Science of Solids 61 (1–3), 1–48. [Google Scholar]
- Küttler U, Wall WA, 2008. Fixed-point fluid-structure interaction solvers with dynamic relaxation. Computational Mechanics 43 (1), 61–72. [Google Scholar]
- Lee Y-U, Lee A, Humphrey J, Rausch M, 2015. Histological and biomechanical changes in a mouse model of venous thrombus remodeling. Biorheology 52 (3), 235–245. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Maas SA, Ellis BJ, Ateshian GA, Weiss JA, 2012. Febio: finite elements for biomechanics. Journal of Biomechanical Engineering 134 (1), 011005. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Maas SA, Ellis BJ, Rawlins DS, Weiss JA, 2016a. Finite element simulation of articular contact mechanics with quadratic tetrahedral elements. Journal of Biomechanics 49 (5), 659–667. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Maas SA, Erdemir A, Halloran JP, Weiss JA, 2016b. A general framework for application of prestrain to computational models of biological materials. Journal of the Mechanical Behavior of Biomedical Materials 61, 499–510. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Martins PALS, Natal Jorge RM, Ferreira AJM, 2006. A comparative study of several material models for prediction of hyperelastic properties: Application to silicone-rubber and soft tissue. Strain 42 (3), 135–147. [Google Scholar]
- Rausch MK, Karniadakis GE, Humphrey JD, 2016a. Modeling soft tissue damage and failure using a combined particle/continuum approach. Biomechanics and Modeling in Mechanobiology 16, 249–261. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Rausch MK, Bothe W, Kvitting J-PE, Goktepe S, Miller DC, Kuhl E, 2011. In vivo dynamic strains of the ovine anterior mitral valve leaflet. Journal of Biomechanics 44 (6), 1149–1157. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Rausch MK, Famaey N, Shultz TO, Bothe W, Miller DC, Kuhl E, 2013. Mechanics of the mitral valve. Biomechanics and Modeling in Mechanobiology 12 (5), 1053–1071. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Rausch MK, Kuhl E, 2014. On the mechanics of growing thin biological membranes. Journal of the Mechanics and Physics of Solids 63, 128–140. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Rausch MK, Zöllner AM, Genet M, Baillargeon B, Bothe W, Kuhl E, 2016b. A virtual sizing tool for mitral valve annuloplasty. International Journal for Numerical Methods in Biomedical Engineering. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Riveros F, Chandra S, Finoal EA, Gasser TC, Rodriguez JF, 2013. A pull-back algorithm to determine the unloaded vascular geometry in anisotropic hyperelastic AAA passive mechanics. Annals of Biomedical Engineering 41 (4), 694–708. [DOI] [PubMed] [Google Scholar]
- Sellier M, 2011. An iterative method for the inverse elasto-static problem. Journal of Fluids and Structures 27 (8), 1461–1470. [Google Scholar]
- Tepole AB, Gart M, Purnell CA, Gosain AK, Kuhl E, 2016. The incompatibility of living systems: Characterizing growth-induced incompatibilities in expanded skin. Annals of Biomedical Engineering 44 (5), 1734–1752. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Trabelsi O, Davis FM, Rodriguez-Matas JF, Duprey A, Avril S, 2015. Patient specific stress and rupture analysis of ascending thoracic aneurysms. Journal of Biomechanics 48 (10), 1836–1843. [DOI] [PubMed] [Google Scholar]
- Weisbecker H, Pierce DM, Holzapfel GA, 2014. A generalized prestressing algorithm for finite element simulations of preloaded geometries with application to the aorta. International Journal for Numerical Methods in Biomedical Engineering 30 (9), 857–872. [DOI] [PubMed] [Google Scholar]
- Weiss JA, Maker BN, Govindjee S, 1996. Finite element implementation of incompressible, transversely isotropic hyperelasticity. Computer Methods in Applied Mechanics and Engineering 135 (1–2), 107–128. [Google Scholar]
- Wittek A, Karatolios K, Bihari P, Schmitz-Rixen T, Moosdorf R, Vogt S, Blase C, 2013. In vivo determination of elastic properties of the human aorta based on 4d ultrasound data. Journal of the mechanical behavior of biomedical materials 27, 167–183. [DOI] [PubMed] [Google Scholar]