Skip to main content
Biophysical Journal logoLink to Biophysical Journal
. 2015 Jun 2;108(11):2613–2618. doi: 10.1016/j.bpj.2015.04.014

Exploring the Dynamics of Cell Processes through Simulations of Fluorescence Microscopy Experiments

Juan Angiolini 1, Nicolas Plachta 2,3, Esteban Mocskos 4,5,, Valeria Levi 1,∗∗
PMCID: PMC4457496  PMID: 26039162

Abstract

Fluorescence correlation spectroscopy (FCS) methods are powerful tools for unveiling the dynamical organization of cells. For simple cases, such as molecules passively moving in a homogeneous media, FCS analysis yields analytical functions that can be fitted to the experimental data to recover the phenomenological rate parameters. Unfortunately, many dynamical processes in cells do not follow these simple models, and in many instances it is not possible to obtain an analytical function through a theoretical analysis of a more complex model. In such cases, experimental analysis can be combined with Monte Carlo simulations to aid in interpretation of the data. In response to this need, we developed a method called FERNET (Fluorescence Emission Recipes and Numerical routines Toolkit) based on Monte Carlo simulations and the MCell-Blender platform, which was designed to treat the reaction-diffusion problem under realistic scenarios. This method enables us to set complex geometries of the simulation space, distribute molecules among different compartments, and define interspecies reactions with selected kinetic constants, diffusion coefficients, and species brightness. We apply this method to simulate single- and multiple-point FCS, photon-counting histogram analysis, raster image correlation spectroscopy, and two-color fluorescence cross-correlation spectroscopy. We believe that this new program could be very useful for predicting and understanding the output of fluorescence microscopy experiments.

Introduction

Fluorescence correlation spectroscopy (FCS) methods (1–7) are widely used to explore the dynamics of biological processes (8). FCS consists of the analysis of intensity fluctuations caused by fluorescently labeled molecules moving through the small observation volume of a confocal or two-photon excitation microscope. Since the temporal window of these fluctuations is given by the processes that determine the mobility of the molecules and their photophysics, this technique has been extensively applied to study diffusion, transport, chemical reactions, etc. (reviewed in Elson (9)). Analysis of fluorescence intensity fluctuations also provides the local concentration of fluorescent molecules and their brightness, which can be used to detect the formation of molecular complexes (10,11). The great innovations made in fluorescence fluctuation measurements will probably produce new and useful approaches to be applied to an increasingly wide range of subjects (8).

For simple cases, such as molecules following Brownian motion, FCS analysis yields analytical functions that can be fitted to the experimental data to recover the phenomenological parameters (e.g., diffusion coefficients and chemical rate constants). Unfortunately, many dynamical processes in cells do not follow these simple models, and in many instances it is not possible to obtain an analytical function through a theoretical analysis of a more complex model (9). In such cases, the analysis can be combined with Monte Carlo simulations (for example, see Dix et al. (12) and the SimFCS program from the Laboratory for Fluorescence Dynamics, University of California, Irvine (UCI), Irvine, CA; http://www.lfd.uci.edu/globals/). A comparison of experimental data and the predictions of a reduced, simulated model could provide important clues about the dynamical processes hidden in the FCS data.

Most of the Monte Carlo methods used to simulate FCS experiments consist of ad hoc tools designed for specific scenarios, which makes it difficult for an inexperienced user to adapt the routine to a different situation. Moreover, these routines usually assume homogeneous systems and do not allow inclusion of a user-defined geometry (12,13), which is necessary to describe, for example, the complex architecture of cells.

In this work, we present FERNET (Fluorescence Emission Recipes and Numerical routines Toolkit), a new, to our knowledge, toolkit we designed to simulate the output of a variety of FCS-based techniques in user-defined scenarios. This program works in combination with the MCell-Blender platform (14–16), which was designed to treat the reaction-diffusion problem under realistic scenarios. The program can be used on standard desktop computers with no special hardware requirements, and allows the user to define the architecture of the space and reactions among species, opening up a wide range of possible simulation scenarios. We believe that this new program will be useful for predicting and interpreting the output of fluorescence fluctuation experiments.

Materials and Methods

Simulation of dynamical processes

MCell is a tool that was designed to capture the complexity involved in biological processes such as signaling and metabolic pathways, which include interactions between various components in solution and/or in structures. This program has several advantages with respect to other simulation tools because the standard approximation for reaction-diffusion systems ignores the discrete nature of the reactants and the stochastic character of their interactions, whereas techniques based on the chemical master equation, such as the Gillespie algorithm (17), assume that at each instant the particles are uniformly distributed in space.

The MCell package (http://mcell.org) includes optimized routines to support Brownian dynamics to model the diffusion of individual molecules in volumes or surfaces, ray tracing of random walk motion vectors to detect collisions among molecules, ray marching to propagate rays after collisions, and Monte Carlo probabilities to decide which collisions lead to reaction events (14–16). The particles move diffusively and it is assumed that if a reaction exists, it follows a Poisson process and happens instantaneously. This allows one to decouple the reaction event from the diffusive motion of the particle. The time step of the algorithm is determined such that only single particles or pairs of particles have to be considered, avoiding complex reaction rules.

To deal with the definition of the complex environment for the simulation, MCell is combined with CAD program Blender (http://www.blender.org) using the CellBlender plugin. Blender provides a broad spectrum of modeling, texturing, lighting, animation, and video postprocessing functionalities in one package. The combination of these tools allows one to create realistic 3D scenarios that can be used to simulate the complexity of the underlying biological processes.

Obtaining fluorescence intensity traces with FERNET

FERNET generates fluorescence intensity traces and images from MCell simulations according to the algorithm schematized in Fig. 1. For the simulations presented in this work, we considered a Gaussian confocal volume; however, the size of the observation volume can be easily modified, as indicated in File S1 in the Supporting Material. At every simulation time step, the program evaluates the position of each particle and calculates the probability of emission (g) as follows (5):

g(x,y,z)=exp(2((xx0)2+(yy0)2)ωxy2+2(zz0)2ωz2), (1)

where ωxy and ωz are the radial and axial waists of the point spread function (PSF), respectively, and (x0, y0, z0) is the center of the confocal volume.

Figure 1.

Figure 1

(A and B) Schematic representation of the MCell-FERNET workflow (A) and FERNET routine (B).

To determine whether the molecule is excited, the value of g is compared with a random number between 0 and 1; if the former is greater, the molecule is considered to be promoted to an excited state. To determine whether the excited molecule emits photons, a random number between 0 and 1 is compared with the value of q, defined as q = ε′⋅ κ, where ε′ is the molecular brightness (in counts per second per molecule) and κ is the dwell time between emission events. The molecule emits if the random number is higher than q. The user can set the values of ε and κ as desired; we included as default parameters ε′ = 105 cpsm and κ = 200 ns (12).

To determine the number of photons emitted by the molecule during the sampling time set by the user (ts), the program repeats this last step ts/κ times, assuming that the position of the simulated molecule is approximately constant during ts. This statement may not be true for fast-moving molecules; therefore, the program compares ts with the mean residency time for the fastest molecule (τD): if τD < 10 ts, the program suggests that ts be modified to correctly sample the simulated system.

This procedure is repeated with all of the molecules at every simulation time step, and the intensity trace is then calculated by adding up the photons emitted by the molecules at each time step.

To ensure that the fluorescence experiments were simulated in the equilibrium condition, we first ran MCell, let the system evolve to equilibrium, and set the obtained concentration of the species as initial parameters for the MCell-FERNET routine.

Correlation functions and photon-counting histogram analysis

Correlation functions and photon-counting histograms (PCHs) were calculated from the simulated intensity traces using specific correlation software (SimFCS; Laboratory for Fluorescence Dynamics, UCI) or custom-made MATLAB (The MathWorks, Natick, MA) routines.

The correlation function was calculated as

Gij(τ)=δIi(t)δIj(t+τ)Ii(t)Ij(t), (2)

where δI(t) = I(t) − <I(t)> represents the fluctuation of the intensity (I), the brackets indicate the time average, and τ is the lag time. The subscripts i and j refer to the detection channels. If i = j, then Gii represents the autocorrelation function (ACF), whereas ij corresponds to the cross-correlation function (CCF).

Results and Discussion

We first ran simulations of molecules passively diffusing in a 3D homogeneous medium and calculated the ACF and PCH from the intensity trace recovered in this simple simulation condition (Fig. 2). The continuous lines in the figure represent the best fit of the PCH obtained by using the theoretical PCH function (11) and the fitting of the ACF data to the equation expected for 3D Brownian diffusion (18):

G(τ)=γN1(1+4Dτϖo2)(1+4Dτzo2), (3)

where D is the diffusion coefficient of the molecules, τ is the lag time, N is the mean number of molecules in the confocal volume, γ is a geometric factor that depends on the detection profile for a Gaussian volume γ = 0.35 (18), and ωo and zo are the radial and axial waists of the PSF, respectively.

Figure 2.

Figure 2

Simulation of FCS routines. (A and B) Single-point FCS: a simulation of 300 molecules (ε = 105 cpsm) passively moving with D = 40 μm2/s in a cube (side length = 6 μm) was run with ts = 10 μs during 100 s. The ACF (A) and PCH (B) data calculated from the intensity trace obtained with the FERNET routine were fitted as described in the text (continuous lines), resulting in the parameters detailed in Table 1.

Table 1 shows that both the diffusion coefficient (D) and brightness of molecules (ε) are correctly recovered, illustrating the robustness of the routine presented in this work for single-point FCS measurements.

Table 1.

Simulated and recovered parameters of PCH and RICS analyses

Experiment Parameter Simulation Correlation Analysis PCH Analysis
Single-point FCS D (μm2/s) 40.00 39.79 ± 0.35
N 0.31 0.29 ± 0.01 0.31 ± 0.01
ε (cpm) 1.00 0.92 ± 0.02
RICS D (μm2/s) 40 40.72 ± 0.56
N 0.27 0.28 ± 0.01

Values are expressed as mean ± standard error from 10 independent simulations.

To show the extra possibilities provided by the ability of MCell to create spatial features, we defined two compartments separated by a permeable barrier (Fig. S1 A in the Supporting Material) and considered different diffusion coefficients and brightness levels for molecules in each compartment. Thus, whenever a molecule moves from one compartment to the other (e.g., when moving between cellular compartments with different rheological properties), the diffusion coefficient changes. This process was simulated as a reaction occurring on the membrane: every time a molecule hit the membrane, there was a probability of destroying this molecule and creating a second one with different D and ε values at the same position on the other side of the membrane.

We then calculated the ACF and PCH curves at different positions of the sample as could be done using different multifocal FCS techniques (2,19,20). Fig. S1 shows pseudocolor images of the D, N, and ε values recovered at every analyzed position either by fitting Eq. 3 to the ACFs or by PCH analysis. These maps closely resemble the simulated data, with the exception of the positions intersecting the barrier, which presented intermediate values as expected.

FERNET also includes the possibility of moving the observation volume, allowing simulations of both the image acquisition (Movie S1) and different scanning-FCS routines (1,5–7). Fig. S2 shows the results obtained in a simulated raster-image correlation spectroscopy (RICS) experiment (12). We fitted the correlation matrix as shown in Digman et al. (6) and obtained the expected values of D and N (Table 1).

Two-color cross-correlation FCS (FCCS) is powerful extension of FCS that allows one to detect interactions between molecules (reviewed in Bacia et al. (4)). Thus, we included in the program the possibility of simulating multicolor measurements (see configuration details in Document S2).

To illustrate how this tool could be used to explore interactions, we considered different scenarios involving the binding of molecules to fixed targets. Previous works showed that such simulations are extremely helpful for exploring the interaction of transcription factors (TFs) with chromatin in living cells (13,21). First, we analyzed simple cases in which two molecules (e.g., different TFs labeled with spectrally well-separated fluorophores) interacted with different binding sites (Fig. 3 A) or competed for the same targets (Fig. 3 B). While the ACFs of the two molecules were very similar and showed the diffusion (τdiff ∼0.2–0.5 ms) and binding (τbinding ∼10 ms) components expected according to Michelman-Ribeiro et al. (13), these different scenarios could be clearly distinguished through the cross-correlation analysis.

Figure 3.

Figure 3

Detecting interactions with two-color FCS. Simulations of two-color FCS experiments were run considering two populations of molecules tagged with spectrally separated fluorescent probes (depicted as red circles and green rectangles). The fluorescence intensity of these molecules was assumed to be collected in independent channels (red and green symbols, respectively). (A–D) The ACFs of the intensity obtained for the red (○) and green (□) channels, and the CCFs (gray symbols) were calculated for the following scenarios: (A) noncompetitive binding, (B) competitive binding, (C) complex formation and binding, and (D) sequential binding. The diffusion and binding model proposed by Michelman-Ribeiro et al. (13) was fitted to the ACF and CCF curves in those scenarios in which the assumptions of the model were fulfilled (continuous lines). The simulated and recovered parameters are summarized in Table S1. To see this figure in color, go online.

To show how the versatility of MCell allows one to include user-defined reactions, we considered other interactions that may affect the binding of molecules with targets. In the first case, molecule A (red circle in Fig. 3 C) interacts with molecule B (green rectangle in Fig. 3 C), and the A-B complex binds to the target. This case is similar to a TF whose DNA-binding efficiency is influenced by its interaction with other proteins (e.g., the estrogen receptor requires calmodulin to bind DNA (22,23). Fig. 3 C shows that the CCF presents two components that are compatible with the free diffusion of complexes and their binding to the targets. Also, we simulated a sequential recruitment of A and B to the binding site (e.g., the glucocorticoid receptor bound to chromatin recruits co-regulators involved in receptor-mediated promoter activation (24). The ACFs obtained for the green and red channels were different due to the sequential binding of molecules (Fig. 3 D). In addition, there was a clear, positive cross correlation in a timescale compatible with the binding process.

Recent improvements in microscopy cameras have resulted in more efficient detection and higher acquisition speeds, allowing the simultaneous and parallel collection of intensity traces with a millisecond time resolution. This development constitutes the basis of imaging-FCS, in which microscopy techniques such as total internal reflection fluorescence microscopy and selective plane illumination microscopy, which confines the excitation to a thin z section of the sample, are combined with FCS (25–27). Given the relevance of these new techniques, we also included in the program the possibility of simulating FCS experiments with camera detection (Fig. S3).

The above examples illustrate how the program can help the user to predict the results of FCS experiments, to rationalize how relevant information can be extracted from experiments, and to understand how different parameters of either the system or the data acquisition could influence the output of the experiments.

For a correct interpretation of the experimental data, these analyses should be combined with an adequate selection of the model based on a strict statistical study that also considers the influence of noise in fluorescence fluctuation measurements and cell-to-cell variability. In recent years, the Bathe group (25,26,28) has developed a Bayesian inference procedure for testing multiple competing models to describe temporal ACFs. This procedure enables the systematic and objective evaluation of different models for FCS data, appropriately penalizing model complexity as the signal/noise ratio decreases.

This group also proposed a statistical blocking procedure (25) that can be easily applied to experimental data to properly estimate the correlated noise present in ACF curves. This step is essential for an unbiased model selection and parameter estimation.

Conclusion

In this work, we have presented, to our knowledge, a new simulation platform based on MCell that allows one to simulate advanced fluorescence microscopy experiments. Because of the easy-to-program options provided by MCell, the MCell-FERNET platform could also be adapted to include a wide variety of photochemical and photophysical processes such as photobleaching and/or photoswitching reactions (12,29), binding to uniform or asymmetrically organized targets (Movie S1), and complex interactions among molecules. We believe that this program could be extremely useful for predicting and understanding the output of fluorescence microscopy experiments.

FERNET and the customized version of MCell can be downloaded from our website (http://www.dc.uba.ar/FERNET).

Author Contributions

E.M., N.P., and V.L. designed research. J.A. and E.M. programmed the custom version of MCell and FERNET. J.A., V.L., and E.M. performed the simulations and data analysis. J.A., E.M., N.P., and V.L. wrote the manuscript.

Acknowledgments

This research was supported by ANPCyT (PICT 2012-0899) and UBACyT (20020110100074). N.P. is supported by a Viertel Foundation Senior Medical Research Fellowship and NHMRC grants APP1052171 and APP1062263. E.M. and V.L. are members of CONICET.

Contributor Information

Esteban Mocskos, Email: emocskos@dc.uba.ar.

Valeria Levi, Email: vlevi12@gmail.com.

Supporting Material

Document S1. Three figures and one table
mmc1.pdf (728.6KB, pdf)
Document S2. User manual of FERNET toolkit
mmc2.pdf (358.3KB, pdf)
Movie S1. Simulating confocal imaging

MCell-Blender was programmed to simulate a complex geometrical model in which green fluorescent molecules are covalently bound to a filamentous structure (e.g., a microtubule), and red fluorescent molecules diffuse freely on the simulated space and can attach to the filamentous structure and diffuse over it (e.g., microtubule-associated proteins). FERNET was set to perform the raster-scan image acquisition in dual-channel mode to simulate images acquired for this scenario in a confocal microscope.

Download video file (31.1MB, mp4)
Data S1. Parameters used for the simulations presented in Fig. 3
mmc4.zip (12.9KB, zip)
Document S4. Article plus Supporting Material
mmc5.pdf (1.2MB, pdf)

References

  • 1.Ruan Q., Cheng M.A., Mantulin W.W. Spatial-temporal studies of membrane dynamics: scanning fluorescence correlation spectroscopy (SFCS) Biophys. J. 2004;87:1260–1267. doi: 10.1529/biophysj.103.036483. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 2.Dertinger T., Pacheco V., Enderlein J. Two-focus fluorescence correlation spectroscopy: a new tool for accurate and absolute diffusion measurements. ChemPhysChem. 2007;8:433–443. doi: 10.1002/cphc.200600638. [DOI] [PubMed] [Google Scholar]
  • 3.Burkhardt M., Schwille P. Electron multiplying CCD based detection for spatially resolved fluorescence correlation spectroscopy. Opt. Express. 2006;14:5013–5020. doi: 10.1364/oe.14.005013. [DOI] [PubMed] [Google Scholar]
  • 4.Bacia K., Kim S.A., Schwille P. Fluorescence cross-correlation spectroscopy in living cells. Nat. Methods. 2006;3:83–89. doi: 10.1038/nmeth822. [DOI] [PubMed] [Google Scholar]
  • 5.Hebert B., Costantino S., Wiseman P.W. Spatiotemporal image correlation spectroscopy (STICS) theory, verification, and application to protein velocity mapping in living CHO cells. Biophys. J. 2005;88:3601–3614. doi: 10.1529/biophysj.104.054874. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 6.Digman M.A., Brown C.M., Gratton E. Measuring fast dynamics in solutions and cells with a laser scanning microscope. Biophys. J. 2005;89:1317–1327. doi: 10.1529/biophysj.105.062836. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 7.Hinde E., Cardarelli F., Gratton E. In vivo pair correlation analysis of EGFP intranuclear diffusion reveals DNA-dependent molecular flow. Proc. Natl. Acad. Sci. USA. 2010;107:16560–16565. doi: 10.1073/pnas.1006731107. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 8.Elson E.L. 40 years of FCS: how it all began. Methods Enzymol. 2013;518:1–10. doi: 10.1016/B978-0-12-388422-0.00001-7. [DOI] [PubMed] [Google Scholar]
  • 9.Elson E.L. Fluorescence correlation spectroscopy: past, present, future. Biophys. J. 2011;101:2855–2870. doi: 10.1016/j.bpj.2011.11.012. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 10.Chen Y., Müller J.D., Gratton E. Molecular brightness characterization of EGFP in vivo by fluorescence fluctuation spectroscopy. Biophys. J. 2002;82:133–144. doi: 10.1016/S0006-3495(02)75380-0. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 11.Chen Y., Müller J.D., Gratton E. The photon counting histogram in fluorescence fluctuation spectroscopy. Biophys. J. 1999;77:553–567. doi: 10.1016/S0006-3495(99)76912-2. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 12.Dix J.A., Hom E.F., Verkman A.S. Fluorescence correlation spectroscopy simulations of photophysical phenomena and molecular interactions: a molecular dynamics/monte carlo approach. J. Phys. Chem. B. 2006;110:1896–1906. doi: 10.1021/jp055840k. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 13.Michelman-Ribeiro A., Mazza D., McNally J.G. Direct measurement of association and dissociation rates of DNA binding in live cells by fluorescence correlation spectroscopy. Biophys. J. 2009;97:337–346. doi: 10.1016/j.bpj.2009.04.027. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 14.Stiles J.R., Van Helden D., Salpeter M.M. Miniature endplate current rise times less than 100 microseconds from improved dual recordings can be modeled with passive acetylcholine diffusion from a synaptic vesicle. Proc. Natl. Acad. Sci. USA. 1996;93:5747–5752. doi: 10.1073/pnas.93.12.5747. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 15.Kerr R.A., Bartol T.M., Stiles J.R. Fast Monte Carlo simulation methods for biological reaction-diffusion systems in solution and on surfaces. SIAM J. Sci. Comput. 2008;30:3126. doi: 10.1137/070692017. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 16.Stiles J.R., Bartol T.M. Monte Carlo methods for simulating realistic synaptic microphysiology using MCell. In: De Schutter E., editor. Computational Neuroscience: Realistic Modeling for Experimentalists. CRC Press; Boca Raton: 2001. pp. 87–127. [Google Scholar]
  • 17.Gillespie D. A general method for numerically simulating the stochastic time evolution of coupled chemical reactions. J. Comput. Phys. 1976;22:403–434. [Google Scholar]
  • 18.Lakowicz J.R. Springer; New York: 2006. Principles of Fluorescence Spectroscopy. [Google Scholar]
  • 19.Kannan B., Har J.Y., Wohland T. Electron multiplying charge-coupled device camera based fluorescence correlation spectroscopy. Anal. Chem. 2006;78:3444–3451. doi: 10.1021/ac0600959. [DOI] [PubMed] [Google Scholar]
  • 20.Sisan D.R., Arevalo R., Urbach J.S. Spatially resolved fluorescence correlation spectroscopy using a spinning disk confocal microscope. Biophys. J. 2006;91:4241–4252. doi: 10.1529/biophysj.106.084251. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 21.Mazza D., Stasevich T.J., McNally J.G. Monitoring dynamic binding of chromatin proteins in vivo by fluorescence correlation spectroscopy and temporal image correlation spectroscopy. Methods Mol. Biol. 2012;833:177–200. doi: 10.1007/978-1-61779-477-3_12. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 22.Cifuentes E., Mataraza J.M., Reddy G.P. Physical and functional interaction of androgen receptor with calmodulin in prostate cancer cells. Proc. Natl. Acad. Sci. USA. 2004;101:464–469. doi: 10.1073/pnas.0307161101. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 23.Li L., Li Z., Sacks D.B. The transcriptional activity of estrogen receptor-alpha is dependent on Ca2+/calmodulin. J. Biol. Chem. 2005;280:13097–13104. doi: 10.1074/jbc.M410642200. [DOI] [PubMed] [Google Scholar]
  • 24.Ratman D., Vanden Berghe W., De Bosscher K. How glucocorticoid receptors modulate the activity of other transcription factors: a scope beyond tethering. Mol. Cell. Endocrinol. 2013;380:41–54. doi: 10.1016/j.mce.2012.12.014. [DOI] [PubMed] [Google Scholar]
  • 25.Guo S.M., Bag N., Bathe M. Bayesian total internal reflection fluorescence correlation spectroscopy reveals hIAPP-induced plasma membrane domain organization in live cells. Biophys. J. 2014;106:190–200. doi: 10.1016/j.bpj.2013.11.4458. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 26.Guo S.M., He J., Bathe M. Bayesian approach to the analysis of fluorescence correlation spectroscopy data II: application to simulated and in vitro data. Anal. Chem. 2012;84:3880–3888. doi: 10.1021/ac2034375. [DOI] [PubMed] [Google Scholar]
  • 27.Wohland T., Shi X., Stelzer E.H. Single plane illumination fluorescence correlation spectroscopy (SPIM-FCS) probes inhomogeneous three-dimensional environments. Opt. Express. 2010;18:10627–10641. doi: 10.1364/OE.18.010627. [DOI] [PubMed] [Google Scholar]
  • 28.He J., Guo S.M., Bathe M. Bayesian approach to the analysis of fluorescence correlation spectroscopy data I: theory. Anal. Chem. 2012;84:3871–3879. doi: 10.1021/ac2034369. [DOI] [PubMed] [Google Scholar]
  • 29.Kolin D.L., Costantino S., Wiseman P.W. Sampling effects, noise, and photobleaching in temporal image correlation spectroscopy. Biophys. J. 2006;90:628–639. doi: 10.1529/biophysj.105.072322. [DOI] [PMC free article] [PubMed] [Google Scholar]

Associated Data

This section collects any data citations, data availability statements, or supplementary materials included in this article.

Supplementary Materials

Document S1. Three figures and one table
mmc1.pdf (728.6KB, pdf)
Document S2. User manual of FERNET toolkit
mmc2.pdf (358.3KB, pdf)
Movie S1. Simulating confocal imaging

MCell-Blender was programmed to simulate a complex geometrical model in which green fluorescent molecules are covalently bound to a filamentous structure (e.g., a microtubule), and red fluorescent molecules diffuse freely on the simulated space and can attach to the filamentous structure and diffuse over it (e.g., microtubule-associated proteins). FERNET was set to perform the raster-scan image acquisition in dual-channel mode to simulate images acquired for this scenario in a confocal microscope.

Download video file (31.1MB, mp4)
Data S1. Parameters used for the simulations presented in Fig. 3
mmc4.zip (12.9KB, zip)
Document S4. Article plus Supporting Material
mmc5.pdf (1.2MB, pdf)

Articles from Biophysical Journal are provided here courtesy of The Biophysical Society

RESOURCES