Realistic Microstructure Simulator (RMS): Monte Carlo simulations of diffusion in three-dimensional cell segmentations of microscopy images

https://doi.org/10.1016/j.jneumeth.2020.109018Get rights and content

Highlights

  • RMS is an open-sourced Monte Carlo pipeline of diffusion simulations.

  • RMS focuses on diffusion, exchange and other contrasts in realistic permeable cells.

  • The implementation of corner reflections largely reduces the computational load.

  • Accurate simulation of exchange requires additional correction terms.

  • Precision is further achieved by GPU-based parallel computations.

Abstract

Background

Monte Carlo simulations of diffusion are commonly used as a model validation tool as they are especially suitable for generating the diffusion MRI signal in complicated tissue microgeometries.

New method

Here we describe the details of implementing Monte Carlo simulations in three-dimensional (3d) voxelized segmentations of cells in microscopy images. Using the concept of the corner reflector, we largely reduce the computational load of simulating diffusion within and exchange between multiple cells. Precision is further achieved by GPU-based parallel computations.

Results

Our simulation of diffusion in white matter axons segmented from a mouse brain demonstrates its value in validating biophysical models. Furthermore, we provide the theoretical background for implementing a discretized diffusion process, and consider the finite-step effects of the particle-membrane reflection and permeation events, needed for efficient simulation of interactions with irregular boundaries, spatially variable diffusion coefficient, and exchange.

Comparison with existing methods

To our knowledge, this is the first Monte Carlo pipeline for MR signal simulations in a substrate composed of numerous realistic cells, accounting for their permeable and irregularly-shaped membranes.

Conclusions

The proposed RMS pipeline makes it possible to achieve fast and accurate simulations of diffusion in realistic tissue microgeometry, as well as the interplay with other MR contrasts. Presently, RMS focuses on simulations of diffusion, exchange, and T1 and T2 NMR relaxation in static tissues, with a possibility to straightforwardly account for susceptibility-induced T2* effects and flow.

Introduction

The MRI measurements of self-diffusion of water molecules in biological tissues provide the sensitivity to the diffusion length scales ranging from microns to tens of microns at clinically feasible diffusion times. As the feasible range of diffusion lengths is commensurate with the sizes of cells, diffusion MRI allows one to evaluate pathological changes in tissue microstructure in vivo. To balance between accuracy and precision in estimation of tissue parameters through biophysical modeling of diffusion MR signal, assumptions are inevitably made to simplify tissue microgeometry (Grebenkov, 2007, Jones, 2010, Kiselev, 2017, Jelescu and Budde, 2017, Alexander et al., 2018, Novikov et al., 2019). It is necessary to validate the assumptions of models before use, either through experiments in physical phantoms (Fieremans and Lee, 2018), or testing the model functional forms in animals and human subjects (Novikov et al., 2018a), or numerical simulations (Fieremans and Lee, 2018).

So far, numerical simulation is the most flexible and economic choice among all kinds of validation. Benefiting from the recent advances in microscopy, realistic cell geometries for simulations have been directly reconstructed from the microscopy data of neuronal tissues in 2 dimension (2d) (Chin et al., 2002, Xu et al., 2018) and 3d (Nguyen et al., 2018, Palombo et al., 2019, Lee et al., 2020b, Lee et al., 2020a), as shown in Fig. 1. The emerging need for simulations in realistic substrates prompts the development of open-source software congenial to physicists, biologists and clinicians.

Here, we describe our implementation of Monte Carlo (MC)-based diffusion simulations: the Realistic Microstructure Simulator (RMS), which entails a fast and accurate model validation pipeline. While our pipeline has been recently announced and applied to simulate diffusion MRI in axonal microstructure (Lee et al., 2020b, Lee et al., 2020a, Lee et al., 2020d), these publications are mainly focused on the physics of diffusion and model validation. In this work, we describe the methodology in detail, building on the algorithms introduced by our team over the past decade (Fieremans et al., 2008, Fieremans et al., 2010, Novikov et al., 2011, Novikov et al., 2014, Burcaw et al., 2015, Fieremans and Lee, 2018, Lee et al., 2020c), and in particular, derive the finite MC-step effects relevant for the interactions (reflection and permeation) of random walkers and membranes.

RMS is introduced as follows. In Section 2, we provide an overview of RMS implementation. Theoretical results and implementation details of particle-membrane collisions and exchange are presented in Appendices A and B; the first order correction of membrane permeability due to a discretized diffusion process is derived in Appendix C. In Section 3, we demonstrate the application of RMS to diffusion simulations in realistic axonal shapes reconstructed from electron microscopy data of a mouse brain (Lee et al., 2019). Simulated diffusion MR signals are shown to be closely related to features of cell shape, facilitating the interpretation of diffusion measurements in biological tissues. Finally, in Section 4 we provide an outlook for microstructure simulation tools in general, and RMS in particular, as a platform for MR-relevant simulations of diffusion and relaxation in microscopy-based realistic geometries.

Section snippets

Realistic Microstructure Simulator: an overview

The goal of our RMS implementation is to provide a universal platform of MC simulations of diffusion in any realistic microgeometry based on microscopy data. Therefore, the RMS has the following properties:

  • (i)

    The simulation is performed in 3d continuous space with voxelized microgeometry. We will introduce this main feature of RMS in Section 2.1.1.

  • (ii)

    The particle-membrane interaction of impermeable membrane is modeled as classic elastic collision. The reason for this choice will be explained in

RMS applied to intra-axonal microstructure

In this section, we describe an RMS-compatible example of a realistic electron microscopy (EM) tissue segmentation (Section 3.1), give an overview of the related biophysical models (Section 3.2), describe the RMS settings for MC in axonal geometry (Section 3.3), and outline our results for the diffusion along (Section 3.4) and transvere (Section 3.5) to the axons.

All procedures performed in studies involving animals were in accordance with the ethical standards of New York University School of

Outlook

Performing MC simulations in realistic cell geometries using the proposed RMS helps to test the sensitivity of diffusion MRI to tissue features and validate the biophysical models. RMS is an open-source platform for the Monte Carlo simulations of diffusion in realistic tissue microstructure. In addition to the examples of diffusion within intra-cellular space, it is also possible to perform simulations of diffusion in the extra-cellular space, as well as of the exchange between intra- and

Conclusions

Numerical simulations in realistic 3d microgeometry based on microscopy data serve as a critical validation step for biophysical models, in order to obtain quantitative biomarkers, e.g., axonal diameter, the degree of caliber variations and axonal undulations, for potential clinical applications. With the help of the proposed RMS pipeline, it is possible to achieve fast and accurate simulations of diffusion in realistic tissue microstructure, as well as the interplay with other MR contrasts.

Data and code availability statement

The SEM data and axon segmentation can be downloaded on our web page (www.cai2r.net/resources/software).

The source codes of Monte Carlo simulations can be downloaded on our Github page (github.com/NYU-DiffusionMRI/monte-carlo-simulation-3D-RMS). The first release of RMS supports simulations of multiple MR contrasts (diffusion, T2 relaxation, water exchange) and the pulsed-gradient spin-echo sequence. Simulations of other MR contrasts (MT and T1 relaxation), sequences (stimulated-echo),

Author contribution statement

Hong-Hsi Lee: Software, Validation, Formal analysis, Methodology, Investigation, Writing – Original Draft, Visualization.

Els Fieremans: Conceptualization, Methodology, Investigation, Resources, Writing – Review & Editing, Supervision, Project administration, Funding acquisition.

Dmitry S. Novikov: Conceptualization, Methodology, Investigation, Resources, Writing – Review & Editing, Supervision, Project administration, Funding acquisition.

Declarations of interest

None declared.

Acknowledgements

We would like to thank Sune Jespersen for fruitful discussions about theory, and the BigPurple High Performance Computing Center of New York University Langone Health for numerical computations on the cluster. Research was supported by the National Institute of Neurological Disorders and Stroke of the NIH under awards R01 NS088040 and R21 NS081230, by the National Institute of Biomedical Imaging and Bioengineering (NIBIB) of the NIH under award number U01 EB026996, and by the Irma T. Hirschl

References (58)

  • H.H. Lee et al.

    In vivo observation and biophysical interpretation of time-dependent diffusion in human cortical gray matter

    NeuroImage

    (2020)
  • K.V. Nguyen et al.

    Efficient GPU-based Monte-Carlo simulation of diffusion in real astrocytes reconstructed from confocal microscopy

    J. Magn. Reson.

    (2018)
  • D.S. Novikov et al.

    Rotationally-invariant mapping of scalar and orientational metrics of neuronal microstructure with diffusion MRI

    NeuroImage

    (2018)
  • M. Palombo et al.

    A generative model of realistic brain cells with application to numerical simulation of the diffusion-weighted MR signal

    NeuroImage

    (2019)
  • M. Palombo et al.

    Can we detect the effect of spines and leaflets on the diffusion of brain intracellular metabolites?

    NeuroImage

    (2018)
  • W. Slijkerman et al.

    Determination of surface relaxivity from NMR diffusion measurements

    Magn. Reson. Imaging

    (1998)
  • D. Topgaard

    Multidimensional diffusion MRI

    J. Magn. Reson.

    (2017)
  • J. Veraart et al.

    On the scaling behavior of water diffusion in human brain white matter

    NeuroImage

    (2019)
  • C.A. Waudby et al.

    GPU accelerated Monte Carlo simulation of pulsed-field gradient NMR experiments

    J. Magn. Reson.

    (2011)
  • K.L. West et al.

    A revised model for estimating g-ratio from MRI

    NeuroImage

    (2016)
  • R. Adams et al.

    Seeded region growing

    IEEE Trans. Pattern Anal. Mach. Intell.

    (1994)
  • D.C. Alexander et al.

    Imaging brain microstructure with diffusion MRI: practicality and applications

    NMR Biomed.

    (2018)
  • J. Brabec et al.

    Time-dependent diffusion in undulating thin fibers: impact on axon diameter estimation

    NMR Biomed.

    (2020)
  • P.T. Callaghan

    Principles of Nuclear Magnetic Resonance Microscopy

    (1993)
  • C.L. Chin et al.

    Biexponential diffusion attenuation in the rat spinal cord: computer simulations based on anatomic images of axonal architecture

    Magn. Reson. Med.

    (2002)
  • A. Einstein

    On the motion of small particles suspended in liquids at rest required by the molecular-kinetic theory of heat

    Ann. Phys.

    (1905)
  • E. Fieremans et al.

    Monte Carlo study of a two-compartment exchange model of diffusion

    NMR Biomed.

    (2010)
  • J.C. Ford et al.

    Numerical model for calculation of apparent diffusion coefficients (adc) in permeable cylinders–comparison with measured adc in spinal cord white matter

    Magn. Reson. Med.

    (1997)
  • D.S. Grebenkov

    NMR survey of reflected brownian motion

    Rev. Modern Phys.

    (2007)
  • Cited by (15)

    • Connecting macroscopic diffusion metrics of cardiac diffusion tensor imaging and microscopic myocardial structures based on simulation

      2022, Medical Image Analysis
      Citation Excerpt :

      Therefore, investigating myocardial fiber architecture is an important technique to explore the physiological and pathological properties of the heart (Helm et al., 2006). To address this problem, numerous modeling and simulation methods have been proposed to simulate diffusion signals by tracking the diffusion displacement of water molecules in a controlled geometric model (Wang et al., 2012; Ianuş et al., 2016; Gilani et al., 2017; Bates et al., 2017; Rensonnet et al., 2019; Brusini et al., 2019; Nguyen et al., 2018b; Sapkota et al., 2016; Lee et al., 2020a). As the microstructure configuration is controlled, numerical simulation provides a valuable tool to accurately investigate the relationship between macroscopic diffusion metrics and underlying microscopic structures.

    • Physical and digital phantoms for validating tractography and assessing artifacts

      2021, NeuroImage
      Citation Excerpt :

      The multiple correlation function tool (MCF) (Laun, 2012) and UCL Camino Diffusion MRI Toolkit3 are two openly available software packages that enable such simulations. Recently, another open-source approach was introduced in Lee et al. (2021) that implements Monte Carlo simulations in 3D voxelized segmentations of cells in microscopy images. These approaches focus on the actual diffusion modeling and are frequently used for the development or evaluation of localized methods, such as signal reconstruction or the analysis of microstructure.

    • Comparative analysis of signal models for microscopic fractional anisotropy estimation using q-space trajectory encoding

      2021, NeuroImage
      Citation Excerpt :

      Nevertheless, the simulated fibre geometry, generated using the algorithm by Callaghan et al. (2020), resembles real axons and enabled the µFA estimates to be compared to a known ground truth. Finally, although Lee et al. (2021, 2020) have shown that a larger number of random walkers may be necessary to accurately calculate the moments of the displacement distribution, we only analyzed the simulated signal, which had converged, as shown by our results that are in good agreement with previously reported results (Callaghan et al., 2020; Hall and Alexander, 2009; Rafael-Patino et al., 2020). Future studies should address the mentioned limitations to facilitate the optimal use of µFA.

    • Connectome 2.0: Developing the next-generation ultra-high gradient strength human MRI scanner for bridging studies of the micro-, meso- and macro-connectome

      2021, NeuroImage
      Citation Excerpt :

      Furthermore, in silico diffusion studies in realistic axonal shapes of mouse brain EM have demonstrated that the diffusivity time-dependence along axons is mainly due to caliber variations (Lee et al., 2020c), and that axon size estimation can be confounded by the presence of axonal undulations at the diffusion times achievable on clinical and preclinical systems (Lee et al., 2020b). We have developed an open-source software of diffusion simulations in realistic cell geometries from microscopy data (Fieremans and Lee, 2018; Lee et al., 2020a), providing a universal platform of model validation and protocol optimization for microstructural imaging using dMRI. It is important to keep in mind that ex vivo diffusion MRI faces its own challenges in such validation efforts, including the changes in MRI-relevant tissue properties and cell shrinkage incurred by tissue fixation (Roebroeck et al., 2019).

    View all citing articles on Scopus
    View full text