Skip to main content
Biophysical Journal logoLink to Biophysical Journal
. 2018 Jul 3;115(1):9–21. doi: 10.1016/j.bpj.2018.06.003

TraceSpecks: A Software for Automated Idealization of Noisy Patch-Clamp and Imaging Data

Syed Islamuddin Shah 1, Angelo Demuro 2, Don-On Daniel Mak 3, Ian Parker 2,4, John E Pearson 5, Ghanim Ullah 1,
PMCID: PMC6035303  PMID: 29972815

Abstract

Experimental records of single molecules or ion channels from fluorescence microscopy and patch-clamp electrophysiology often include high-frequency noise and baseline fluctuations that are not generated by the system under investigation and have to be removed. Moreover, multiple channels or conductance levels can be present at a time in the data that need to be quantified to accurately understand the behavior of the system. Manual procedures for removing these fluctuations and extracting conducting states or multiple channels are laborious, prone to subjective bias, and likely to hinder the processing of often very large data sets. We introduce a maximal likelihood formalism for separating signal from a noisy and drifting background such as fluorescence traces from imaging of elementary Ca2+ release events called puffs arising from clusters of channels, and patch-clamp recordings of ion channels. Parameters such as the number of open channels or conducting states, noise level, and background signal can all be optimized using the expectation-maximization algorithm. We implement our algorithm following the Baum-Welch approach to expectation-maximization in the portable Java language with a user-friendly graphical interface and test the algorithm on both synthetic and experimental data from the patch-clamp electrophysiology of Ca2+ channels and fluorescence microscopy of a cluster of Ca2+ channels and Ca2+ channels with multiple conductance levels. The resulting software is accurate, fast, and provides detailed information usually not available through manual analysis. Options for visual inspection of the raw and processed data with key parameters are provided, in addition to a range of statistics such as the mean open probabilities, mean open times, mean close times, dwell-time distributions for different number of channels open or conductance levels, amplitude distribution of all opening events, and number of transitions between different number of open channels or conducting levels in asci format with a single click.

Introduction

Recent advances in total internal reflection fluorescence microscopy (TIRFM) provide a powerful tool for the functional study of thousands of Ca2+ release channels simultaneously at single channel resolution in a minimally invasive manner, maintaining the physiological environment of the channels (1, 2, 3). This technique, called “optical patch-clamp,” has been used to study Ca2+ flux through several individual channels, including N-type voltage-gated Ca2+ channels (1, 4, 5), nicotinic acetylcholine receptors (2, 5), and L-type Ca2+ channels in cardiac muscle (5). Optical patch-clamp was also used to resolve the quantal substructure of elementary Ca2+ puffs and sparklets arising from concerted opening of multiple channels in a cluster of inositol 1,4,5-trisphosphate (IP3) receptors (IP3Rs) and dihydropyridine-sensitive voltage-gated CaV1.2 channels, respectively, by directly resolving the opening and closing of individual channels in the cluster (6, 7). Recently, the same technique was employed to resolve the conductance levels in a single ion channel while simultaneously imaging thousands of Ca2+-permeable plasma membrane (PM) pores formed by β-amyloid (Aβ142) in the cells with Alzheimer’s disease pathology (8, 9).

Optical patch-clamp generates thousands of time traces representing the gating of individual channels in a single experiment. However, manual analysis of the data generated is extremely tedious and challenging, which hinders the full utility of this powerful technique. The analysis of fluorescence traces from single channels with single or multiple conductance levels or concerted opening of multiple channels in a cluster of channels (such as IP3Rs, ryanodine receptors, and dihydropyridine-sensitive voltage-gated CaV1.2 channels) obtained from TIRFM requires the removal of background noise and baseline fluctuations in the data records that are not generated by the channels under study. These fluctuations could arise either from the saturation of dye molecules or the drift in measuring equipment itself. Because the data are expected to exhibit quantized steps, the signal and the data (and possibly the noise) have significant autocorrelation times; simple filtering may not yield a clear separation of signal from background and may fail to make use of the known quantal character of the data.

A similar situation arises when using other techniques such as single-channel patch-clamp and single-molecule fluorescence and photobleaching experiments, where analysis of the experimental data first requires the removal of noise and varying background that are not generated by the phenomenon under study (10, 11, 12, 13, 14, 15). In the patch-clamp experiments (16), instabilities in the gigaohm seal formed between the biological membrane patch and the patch-clamp microelectrode often result in substantial fluctuations in the magnitude of the observed current and a drift in the recorded signal. Such baseline fluctuations are usually significantly slower than the abrupt changes in current magnitude caused by opening and closing of the channel and have to be removed before the current traces can be analyzed further by standardized software such as Quantifying Unknown Biophysics (QUB) (17, 18) and Hawkes, Jalali & Colquhoun Fit (HJCFIT) (19) that model the channel gating characteristics based on idealized data.

Existing baseline subtraction algorithms can require substantial time and/or user interaction on ion channel data, as the program forces users to check each individual fit by eye. Without a robust baseline subtraction algorithm, some experimentalists perform this laborious task by hand by following the quantal jumps by eye and subtracting the drifting background. Such a manual background-subtraction procedure requires eyeballing and mouse clicking to indicate the background trajectory, which is time-consuming and susceptible to subjective bias. Although QUB provides three different methods for automated background subtraction, it could over- or underestimate the signal in situations in which the drift is significant. In such a scenario, one can resort to manually selecting the baseline, which can be subjective and time-consuming. Another source of subjectivity arises when the conductance levels are not clearly defined because the user has to specify the number of conductance levels or channels present in the trace and amplitude of each conductance level. Such examples are also frequently observed in the fluorescence traces.

To overcome these obstacles, we previously developed a minimally parameterized likelihood (20) approach for separating the signal from noisy and drifting background, which gives results that agree with the mouse-based method and is much faster (21). However, the requirement to compile and execute the algorithm for processing the data proved to be a major hurdle for experimentalists not familiar with compiled languages. Although the main goal of this study was to extend the algorithm so that it can be used for both patch-clamp electrophysiology and fluorescence data, we develop a user-friendly graphical user interface (GUI) that is easy to use, flexible, and portable. Furthermore, we incorporate several new features in the software that were not included in the previous version. In addition to extracting idealized trace and drifting background, the software extracts many features from the data, including the mean open probabilities (PO); open times (τO); close times (τC); dwell-time distributions for different conductance levels or number of open channels; overall PO, τO, and τC in the trace; amplitude distribution of all events; and transition frequencies between different conductance levels or channels open with a few simple steps. We demonstrate the utility of our software by processing patch-clamp data containing single and multiple channels per trace, fluorescence traces from TIRFM representing Ca2+ signals generated by concerted opening and closing of several channels in a cluster of IP3Rs, and fluorescence traces representing the Ca2+ flux through PM pores with multiple conductance levels, formed by Aβ142 oligomers associated with Alzheimer’s disease pathology.

We would like to point out that TraceSpecks is not a substitute for QUB, HJCFIT, or other similar algorithms (14, 22, 23). It is rather a front-end application that we believe will enhance the utility of these programs, enabling them to model the kinetics of ion channels and single molecules when the time traces are either more challenging or recorded in native environment through tools such as fluorescence microscopy. Furthermore, the source code included with the software provides an opportunity to customize TraceSpecks according to personal preferences.

Methods

In this section, we first outline the main points of the algorithm (detailed derivation of the algorithm can be found in (21)) followed by details of how we generate synthetic records representing patch-clamp electrophysiology of a single ion channel with varying signal-to-noise ratio (SNR) as well as synthetic fluorescence traces representing the concerted opening and closing of multiple channels in a cluster of IP3Rs. A brief description of sample experimental methods and the data used to demonstrate the utility of the software are also given toward the end of this section.

Theory

We use the expectation-maximization (EM) algorithm to estimate the number of open channels or conductance levels, which are treated as missing data. The EM algorithm was originally developed by Baum, Welch et al. in the 1960s and formalized by Dempster et al. (24, 25, 26, 27). Readers interested only in using the software can safely skip this part and move to the user manual included in the online supplement. Readers interested in reproducing the algorithm in another programing language (note that Java source code is included in the online supplement and that Fortran 90 and C versions are available from the authors upon request) can move to the three steps summarizing the algorithm at the end of this section. Those interested in understanding the theory behind the software and modifying the algorithm should read this section and (21) for more details.

Assuming that nt is the number of channels open or the conductance level in which the channel is gating and that i is the current passing through the channel at time t, the observed signal at time t is given by dt = bt + int + σξξt, where ξt is the zero-mean discrete-time Gaussian white noise and σξ is the level of noise. We further assume that the baseline is undergoing a discrete-time random walk, bt = bt1 + σbξ˜t, where ξ˜t is the discrete-time white noise like ξt. Under these assumptions, it follows that dtbt + int and btbt1 are zero-mean Gaussian-distributed random variables with variances σξ2 and σb2, respectively.

The joint distribution for d, b, and n is given as

p(d,b,n;θ)=NeH(d,b,n;θ). (1)

H is given by

H(d,b,n;θ)=12σb2t=1T1(bt+1bt)2+12σξ2t=1T(dtbtint)2, (2)

where T is the number of data points, d=(d1,d2,..,dT), b=(b1,b2,..,bT), n=(n1,n2,..,nT), and θ represents the parameters σξ2, σb2, and i. N is the normalization factor:

N=1neH(d,b,n,θ)dddb. (3)

nn1=0Nchn2=0NchnT=0Nch, and Nch is an upper bound on the number of channels contained in the trace (number of channels patched or number of channels in a cluster of channels). For a single ion channel (or molecule) with multiple equally spaced conductance levels, Nch represents the total number of conductance levels that the system can have, where the closed state of the channel is represented by level 0. dd and db represent the differentials of all the variables being integrated over, e.g., db=t=1Tdbt. In principle, we would like to maximize the likelihood of the data given the model, L(d;θ), as follows:

L(d;θ)nbp(d,b,n;θ)db, (4)

but this is unwieldy. Although the integral over T dimensions can be dealt with, the sum is over at least 2T values and cannot be maximized in one step. Thus, we employ the iterative EM procedure that attempts to find the maximal likelihood estimate of L by first making an initial guess for θ=θ˜ and then iterating the following steps:

Q(θ,θ˜)=logp(d,b,n;θ)p(b,n|d;θ˜) (5)
θ=argmaxθQ(θ,θ˜)
θ˜=θ.

In the above, logp(d,b,n;θ)p(b,n|d;θ˜) denotes the expectation of logp(d,b,n;θ) with respect to the distribution p(b,n|d;θ˜). The EM iteration is known to converge to, at worst, a local maximal likelihood estimate for L(d|θ).

Because of the simple dependence that the likelihood function has on b, we can integrate b out and then employ a slightly modified version of the EM algorithm to solve the remaining maximal likelihood problem (see (21) for the derivation), as follows:

p(d,n;θ,b)p(d,b,n;θ)t=1Tdbt=NeH(d,b,n;θ)t=1Tdbt=NeH(d,b,n;θ) (6)

where b is the maximal likelihood estimate of b found by minimizing H,

Hb|b=b=1σb2Δb+1σξ2(dbin)=0,

and Δ is the finite difference Laplacian: Δbtbt+1+bt12bt. Thus,

b(d,n,θ)=(Δ+R2)1(din), (7)

where R2=σb2/σξ2. As written, b in the argument of p(d,n;θ,b) in Eq. 6 is redundant because b is a known function of d, n, and θ. The reason we have employed this seemingly redundant notation is just to make clear in the algorithm which value of b (old or updated) we used to compute the current expected values of n.

The normalization constant N is given by (see (21) for the derivation)

N1(1+Nch)T(12π)T/21/2(1σξ2)T/21/22T/2R(2+R2+R4+4R2)T/2. (8)

The distribution p(b,n|d;θ˜) needed for Q in Eq. 5 becomes p(n|d,θ˜,b˜) after integrating out b. Here, b˜ is the initial guess for the background signal. To find p(n|d,θ˜,b˜), we note that in general, p(x|y)=p(x,y)/p(y). Thus,

p(n|d,θ˜,b˜)=p(d,n;θ˜,b˜)np(d,n;θ˜,b˜)=eH(d,b˜,n;θ˜)neH(d,b˜,n;θ˜)=t=1Tp(nt|dt,θ˜,t). (9)

The quantity p(nt|dt,θ˜,t) is the conditional probability that there are nt channels open at a single time point t. To simplify the notation, we write p(j|dt,θ˜,t) to indicate the conditional probability that there are j channels open at time t:

p(j|dt,θ˜,t)=exp((dtb˜ti˜j)2σ˜ξ2)k=0Nchexp((dtb˜ti˜k)2σ˜ξ2)=1k=0Ncheηjtηkt, (10)

where ηmt(dtb˜tmi˜)2/2σ˜ξ2 and m=0,1,2,3,Nch. We will use angle brackets without subscripts to denote expectations with respect to p(j|dt,θ˜,t) so that

ntsj=0Nchjsp(j|dt,θ˜,t). (11)

For a single channel or single-molecule recording, Nch=1, and Eq. 11 results in nt=1/eη1tη0t+1.

At this point we can write Q explicitly:

Q(θ,θ˜)=logN12σb2t=1T1(bt+1bt)212σξ2t=1T(dtbtint)2. (12)

The dependence on θ˜ is only through b and the angle brackets. The end result of this calculation is that we replace the dependence in H on powers of nt with the expected value of those powers: ntnt and nt2nt2. We maximize Q(θ,θ˜) by updating θ iteratively in the following steps.

  • Step 0: (Initialization) Make initial guess for b˜t,σξ2,i, and R2: θ˜=(σξ2,i,R2).

  • Step I: (Estimate or Expectation) Update the expected values of nt and nt2 with respect to p(j|dt,θ,t), which we will denote as nt and nt2:

nts=j=0Nchjsp(j|dt,θ,t). (13)

At the end of this step, nt and nt2 in H will be replaced by nt and nt2, respectively.

  • Step II: (Maximize).

Update baseline signal
b=(Δ+R˜2)1(di˜n)

We obtain b with a standard tridiagonal matrix solver, which is very fast. Note the dependence in b is on θ˜ rather than on θ. In steps B, C, and D, we update the parameters i, σξ2, and R2 while keeping b fixed.

Update i

The derivative of Q with respect to i is

Qi=1σξ2t=1T(nt(dtbt)int2).

To maximize Q with respect to i, we set the above equation to zero, which yields

i=t=1T(dtbt)ntt=1Tnt2.

Update σξ2

The derivative of Q with respect to 1/σξ2 is

Q1σξ2=Tσξ2212R2t=1T(btbt1)212t=1T((dtbt)22(dtbt)int+i2nt2)

To maximize Q with respect to σξ2, we set the above equation to zero, which yields

σξ2=1T(1R2t=1T(btbt1)2+t=1T((dtbt)22(dtbt)int+i2nt2). (14)

Update R2

The derivative of Q with respect to R2 is Q/R2=(B/2σξ2R4)T(1+(2+R2/4R2+R4)/2+R2+4R2+R4), where Bt=1T1(bt+1bt)2. The updated R2 is the single real positive root of Q/R2=0. At this point, θ˜=(σξ2,i,R2).

Return to step I

To summarize, we iterate the steps described above in the order of step 0 step I step II step I. In the E step, we compute the Nch expectation values of nt for each t, and in the M step, we update the parameters based on maximizing Q in Eq. 6.

The algorithm is implemented in widely portable Java language in a user-friendly GUI with options to set up initial parameters and graphical display of raw and processed traces. Options to store statistics on the processed data are provided, including mean PO, τO, τC, dwell-time distributions for different conductance levels, or number of open channels for the processed trace. Information regarding the amplitude distribution of all opening events as well as the frequency of transitions between different numbers of open channels or conductance levels are also provided. An example of algorithm’s GUI is shown in Fig. 1. A compiled and portable Java program with the GUI that performs these calculations and the user manual for the software is provided in the online supplement. A Java source code is also included in the online supplement for those interested in customizing the software for their personal use. Fortran 90 and C versions of the software are also available from the authors on request.

Figure 1.

Figure 1

Graphical user interface of TraceSpecks. Various controls for reading, displaying, and saving data sets are provided. Text controls are used to provide input parameters for the algorithm as well as displaying the optimal parameters and results determined by the algorithm. Raw trace, background noise signal, and idealized signals can be viewed in the graphical panel of the GUI for visual inspection and can be zoomed in and out as needed. To see this figure in color, go online.

We remark that TraceSpecks suggests initial values for the four parameters (i, σξ2, R2, and background) based on the nature of the data. In our experience, the software gives good results for fluorescence traces when the initial parameter values suggested by the algorithm are used. However, these are mere suggestions and might result in over- or underestimation of the channel’s activity. We recommend selecting different initial values if the user is not satisfied with the results. We noticed that sometimes the results can be improved by playing with the initial values of the BackgroundFactor (the raw data multiplied by BackgroundFactor gives the initial background) and Current (i) in the case of patch-clamp data. This is the rare weakness of the algorithm, as it requires some intuition about the data. However, by playing with these parameters for a few minutes or running the algorithm at command line (see user manual provided in the online supplement), one gets a good idea for the initial values. Furthermore, the fact that the algorithm allows the initial values to be relatively crude makes this initial phase easier.

Data records

We apply our method to synthetic and experimental data sets from both TIRFM experiments and patch-clamp recordings. Our synthetic data sets comprise two examples, one representing patch-clamp experiments with variable SNR and another one mimicking fluorescence traces from a cluster of IP3Rs (28). The experimental data set consists of nuclear patch-clamp recordings from IP3 in Sf9 cells (29), fluorescence recordings from IP3-induced Ca2+ puffs (30), and Aβ-induced Ca2+-permeable PM pores (8) in Xenopus oocytes.

Synthetic data sets. Details of patch-clamp synthetic data generation can be found in our previous article (21). Briefly, we use 10,000 open and closed events with the duration of these events drawn randomly from a uniform distribution. The range of distribution for closed events is five times that of open events. A channel’s PO is controlled by varying the range of the distribution from which the closed time is drawn. We construct background signal bt = bt1 + σbξ˜t to get final simulated channel trace dt = bt + i nt + σξξt, where ξ˜t and ξt are zero-mean Gaussian noise with deviations σb and σξ, respectively. In addition to background and signal noise, channel current i is also treated as a normal random variable of mean i and deviation σξ. nt is the number of channels open at time t, which is 0 or 1 for the current case but can be higher for the synthetic data of multichannel/multiconductance levels. Although we only use white noise here, the algorithm handles data with correlated noise equally well. We refer readers interested in a detailed discussion on the treatment of correlated noise by the algorithm to (21).

To test the robustness and accuracy of the software toward noise levels present in the experimental data, we generated single-channel synthetic patch-clamp data with SNRs ranging from 2.1 to 12.6, as described below.

As mentioned above, there are two noise sources in our model, ξt and ξ˜t:

SNRξiσξ (15)
SNRbiσbmax(NO,NC) (16)
SNR=iσξ11+R2max(NO,NC), (17)

where NO and NC are the mean number of sampling intervals for open and closed events, respectively. SNRξ is a standard SNR. SNRb indicates how much the baseline drifts relative to the current during the average open or closed event. SNR is the combined SNR: SNR=SNRξ2+SNRb2. Using σξ2=5 and σb2=2, we vary mean current i from 20 to 120 (arbitrary current units) to get an SNR from 2.1 to 12.6.

We also process fluorescence data from a simulated cluster composed of 10 IP3R Ca2+ channels. Details about simulating a single cluster have been published before (28, 31, 32). Briefly, channels were arranged in a two-dimensional array on a patch of endoplasmic reticulum (ER) membrane with an interchannel spacing of 120nm. The gating of each channel is given by a four-state Markov chain model with rest (R), active (A), open (O), and inactivate (I) states connected in a loop (Fig. 2 of (28)). The channel is open when in state O and closed otherwise. The state of each channel was determined by using a stochastic scheme outlined in (33).

Ca2+ concentration on the cytosolic side of the cluster was controlled by diffusion, flux through IP3Rs, free stationary buffers, mobile buffers, and imaging dye. We considered slow mobile buffer mimicking EGTA. The propagation of Ca2+ and buffers was solved implicitly using the Laplacian of Ca2+ and buffers in spherical coordinates on a hemispherical volume of radius 5μm and a spatial grid size of 5nm. We estimated the fluorescence changes (ΔF/F0) from TIRFM by following the procedure in (34, 35), i.e.,

ΔF/F0=j∫∫∫dxdydzbdj(rj(x,y,z))
×((xx0)2σx2(yy0)2σy2)exp(zγz), (18)

where bdj is the Ca2+-bound dye at distance rj(x,y,z) due to Ca2+ released by the jth channel at x0=0,y0=0, σx2=σy2=0.0225μm2, and γz=0.15μm. The integration in Eq. 18 was performed over a cubic volume of 1.5×1.5×0.15μm. To make the simulated TIRFM signal as close to the experiment as possible, we added experimental noise and drifting background extracted from TIRFM of puff sites in Xenopus oocytes to the simulated fluorescence data.

Experimental data sets

Experimental traces of current passing through single IP3R channels, which are ubiquitous intracellular Ca2+-release channels localized mainly to the ER and outer nuclear membranes (36), were acquired by nuclear patch-clamp electrophysiology, as described in (29, 37, 38). Currents passing through outer nuclear membrane patches isolated at the tips of micropipettes were amplified using an Axopatch 200B patch-clamp amplifier (Molecular Devices, Sunnyvale, CA) and filtered either at 1 kHz using a tunable low-pass four-pole Bessel filter (Frequency Devices, Ottawa, IL) or at 5 or 10 KHz using the internal tunable low-pass four-pole Bessel filter of the Axopatch amplifier. The current signals were digitized at 5 kHz using an ITC16 interface (HEKA Instruments, Bellmore, NY) and recorded directly onto a data acquisition computer using the Pulse + PulseFit software (HEKA Instruments).

Full details of TIRFM experiments on IP3-induced puffs are given in (30). Briefly, records of IP3-induced puffs were obtained from Ca2+ imaging of Xenopus laevis oocytes at room temperature by widefield epifluorescence microscopy using an Olympus inverted microscope (IX 71) equipped with a 60×oil-immersion objective, a 488 nm argon ion laser for fluorescence excitation, and a charge-coupled device camera (Cascade 128+; Roper Scientific, Vianen, the Netherlands) for imaging fluorescence emission (510–600 nm) at frame rates of 30–100 s1. Fluorescence was imaged within a 40× 40 μm region within the animal hemisphere of the oocyte, and measurements are expressed as a ratio (ΔF/F0) of the mean change in fluorescence (ΔF) at a given region of interest (1.5×1.5μm) centered on the putative IP3R cluster to the resting fluorescence at that region before stimulation (F0). Mean values of F0 were obtained by averaging over several frames before stimulation. MetaMorph (Molecular Devices) was used for preliminary image processing. Fluorescence traces representing Ca2+ release events due to channel gating in the cluster were extracted from the image sequences using a previously developed software called CellSpecks that can detect all Ca2+ events in a video sequence recorded from a cell’s membrane and extracts fluorescence time traces for individual clusters. Further details about CellSpecks can be found in (8).

Detailed experimental methods for imaging the activity of PM pores formed by Aβ142 oligomers are given in (8). Briefly, solution containing soluble oligomers prepared from human recombinant Aβ1-42 peptide and aliquots were applied using a glass pipette with a tip diameter of ∼30 μm to voltage-clamped oocytes of defolliculated stage VI Xenopus treated with fluo-4 dextran. For imaging, oocytes were placed animal hemisphere down in a chamber whose bottom is formed by a fresh ethanol-washed microscope cover glass (type-545-M; Thermo Fisher Scientific, Waltham, MA) and were bathed in Ringer solution (110 mM NaCl, 1.8 mM CaCl2, 2 mM KCl, and 5 mM Hepes (pH 7.2)) at room temperature (∼23°C) continually exchanged at a rate of ∼0.5 mL/min by a gravity-fed superfusion system. The membrane potential was clamped at a holding potential of 0 mV using a two-electrode voltage clamp (Gene Clamp 500; Molecular Devices) and was stepped to a more negative potential of −100 mV when imaging Ca2+ flux through amyloid pores to increase the driving force for Ca2+ entry into the cytosol. The video sequences generated by TIRFM were processed by CellSpecks to extract fluorescence traces for individual Aβ142 pores.

Results and Discussion

We use TraceSpecks to idealize experimental time traces from patch-clamp experiments with single and multiple channels in the patch, TIRFM of Ca2+ puffs generated by clusters of IP3Rs, fluorescence traces representing the gating of Ca2+-permeable pores formed by Aβ142 oligomers in the PM, simulated TIRFM signals from a cluster of IP3R channels, and synthetic patch-clamp data with variable SNR. In this section, we first demonstrate the robustness and accuracy of our software using synthetic data with variable SNR and then apply it to other data sets mentioned above.

Before presenting our results, we would like to point out that the software uses two different schemes for reporting the dwell-time distributions, mean PO, τO, and τC for different conductance levels or number of open channels in the trace as shown in Fig. 2. Although we only present the dwell-time distributions and other statistics from the first scheme (Fig. 2 a) in the article, TraceSpecks saves the results from both schemes in ascii format in separate files.

Figure 2.

Figure 2

TraceSpecks uses two schemes for calculating open and closed dwell times. As an example, we show an idealized trace with three channels/open conductance levels. (a) In scheme 1, toij and tcij represent the jth dwell time when a minimum of i channels are open (or the channel is gating in conductance level i or above) and the jth dwell time when a minimum of i channels are not open, respectively. (b) In scheme 2, toij represents the jth dwell time when i channels are open (or the channel is gating in conductance level i), and tc1j represents the jth dwell time when no channel is open (or the channel is in closed level). To see this figure in color, go online.

Synthetic data

As described in Methods, using σξ2=5 and σb2=2 and varying mean current i from 20 to 120 (arbitrary units), we have generated synthetic data sets with SNRs ranging from 2.1 to 12.6. As shown in Fig. 3, TraceSpecks idealized these noisy synthetic patch-clamp traces with drifting and variable background and accurately determined various parameters of interest for almost all values of SNR. A sample noisy trace with the background separated by the software and the idealized trace are shown in Fig. 3, a and c, respectively. We also show the actual trace without the noise and background for comparison in Fig. 3 b. We repeat this experiment for many traces with varying SNRs, estimate different features, and compare these estimates with the actual values of these features. In Fig. 3, df, we show the mean-square error for τO, τC, and PO. Even for SNR as small as 2.1, the estimates for these parameters are very good. It is worth mentioning that the SNR in TIRFM experiments is close to 8 (39), whereas that for the patch-clamp electrophysiology is even higher (40). TraceSpecks extracts the exact values for different parameters of interest for traces with SNRs of five or above (Fig. 3, df).

Figure 3.

Figure 3

Processing synthetic patch-clamp data with variable SNR of 2.1–12.6. (a) Sample raw trace is shown with noisy and drifting background (dashed line) and background separated by TraceSpecks (solid line), (b) actual trace, and (c) idealized trace. Mean-square errors are shown for mean τO (d), mean τC (e), and mean PO (f). To see this figure in color, go online.

Application to fluorescence data from a simulated cluster composed of 10 IP3R channels demonstrates (Fig. 4 a, dashed line) that the software works well for multichannel data too. The drifting background separated from the signal by the software is shown by the solid line in Fig. 4 a. The idealized signal representing the expected number of open channels in the cluster at time t is shown in Fig. 4 b. For simulations shown in Fig. 4 a, we also recorded the number of open channels in the cluster that are shown in Fig. 4 c for comparison. It is clear from Fig. 4, b and c that the processed signal closely compares with the actual number of open channels. It should be noted that our method also reports τO, τC, and PO as well as the dwell-time distributions for different numbers of open channels and interchannel transitions (transition from X number of channels open to Y number of channels open at a time t, where Y can be less than or larger than X) for the given trace (data not shown).

Figure 4.

Figure 4

Processing simulated puffs. (a) A noisy and drifting fluorescence time series is generated by a simulated single IP3R cluster with added background extracted from the raw experimental data (dashed line) and the drifting background estimated by the software (solid line). (b) Idealized signal is generated by the software. (c) Number of open channels in the cluster as a function of time from simulation is shown for comparison.

Experimental data

In this section, we demonstrate the application of our method to fluorescence time traces representing IP3-induced Ca2+ puffs by IP3R clusters in the ER membrane and the gating of PM pores formed by Aβ142 oligomers, both observed through TIRFM in Xenopus oocytes as well as traces from nuclear patch-clamp electrophysiology of IP3Rs in Sf9 cells with single and multiple channels per patch.

First, we idealize traces from nuclear patch-clamp electrophysiology of IP3Rs. Although the method works equally well for traces with a single channel per patch (see for example Fig. 3), we only show slightly complex examples of multiple channels per patch. A summary of eight traces with two to four channels per patch is shown in Fig. 5 and Table 1. A sample raw trace with two channels along with the separated background and idealized trace identified by the algorithm is shown in Fig. 5, a and b, respectively. Dwell-time distributions when at least one, two, three, or four channels are open in all eight traces are shown in Fig. 5, ce, respectively. Our method also provides mean POi, τOi, and τCi for at least i channels open for the eight traces (Table 1). For example, PO1 and τO1 are the mean probability and mean open time that at least one channel is open. Similarly, τC1 is the mean time when none of the channels are open (a minimum of one channel is not open), and τC2 is the mean time when either one or zero channels are open (a minimum of two channels are not open).

Figure 5.

Figure 5

Processing current time traces that record the gating of IP3R channels during single-channel patch-clamp electrophysiological experiments using nuclei isolated from Sf9 cells. (a) A typical raw current trace (black) in which two channels were active and the background leak current level (gray) were identified by our software. (b) The number of open channels at any time during the experiment in (a) is shown. Dwell-time distributions when at least one (c), two (d), three (e), or four (f) channels are open in all eight traces processed are shown. To see this figure in color, go online.

Table 1.

Channel Statistics for Eight Traces from Nuclear Patch-Clamp Electrophysiology of IP3Rs in Sf9 Cells with Two, Three, and Four Active Channels per Patch

Trace PO1 PO2 PO3 PO4 τO1ms τO2ms τO3ms τO4ms τC1ms τC2ms τC3ms τC4ms
1 0.91 0.67 166 271 17 128
2 0.41 0.16 642 163 927 8017
3 0.82 0.52 505 790 111 722
4 0.93 0.86 0.38 113 138 171 9 23 278
5 0.41 0.14 0.003 187 275 160 265 1683 36,525
6 0.36 0.14 0.02 29 53 75 51 321 3558
7 0.69 0.41 0.11 0.002 49 72 91 77 22 105 714 21,639
8 0.81 0.60 0.30 0.002 911 1566 2166 1100 219 1048 4922 253,520

Columns 2–5 and 6–9 are the mean probabilities and mean open times, respectively, when at least one, two, three, and four channels are open. Columns 10–13 are the mean closed times when a minimum of one, two, three, and four channels are not open.

We also processed many fluorescence records from TIRFM of IP3-induced Ca2+ puffs in Xenopus oocytes with varying amplitudes (in terms of peak fluorescence or number of open channels during the puff) and duration. We identified up to ten channels in the traces processed and show a range of parameters and statistics extracted from the fluorescence traces by our software in Fig. 6. Fig. 6, a1 and a2 show a raw trace representative of IP3-induced puffs (black) with background noise (gray) and the number of channels identified by TraceSpecks, respectively. The raw TIRFM signal is the relative fluorescence change due to the cluster activity, averaged over a 1.5×1.5μm area surrounding the cluster. As pointed out above, the software allows us to store the mean PO, τO, τC, and dwell-time distributions for different numbers of channels open in the cluster and amplitudes of all puffs in a trace in ascii format for plotting and postprocessing. As an example, we show the distribution of puff amplitudes represented as the maximal number of channels opened simultaneously in a puff from all traces processed in (a3) of Fig. 6.

Figure 6.

Figure 6

Processing fluorescence records from TIRFM of IP3-induced Ca2+ puffs in Xenopus oocytes. The first column on the left shows a sample raw trace (black) and the background separated by the software (gray) (a1), the corresponding idealized trace (a2), amplitude (maximal number of channels open simultaneously) (a3), distribution of all puffs in all traces processed, and the transition between different numbers of channels open/closed (a4). The remaining four columns show distributions of dwell times (first row), mean PO (second row), mean τO (third row), and mean τC (fourth row) when at least one (b1b4), two (c1c4), three (d1d4), and four channels (e1e4) are open in all traces processed. Mean τC for channel i represents the mean time when the number of open channels is less than i. To see this figure in color, go online.

Another key piece of information about the traces representing the activity of multiple channels or single channels with multiple conductance levels is determining the probability of transitions between different numbers of channels opened or different conducting states. For example, what is the likelihood that Y channels will be open at time t+δt given that there are X channels open at time t, where X and Y do not have to be consecutive digits? Or what is the probability that a channel in conductance level X at time t will be in conductance level Y at time t+δt? This information can be used for modeling the kinetics of a single channel with multiple conductance levels or a cluster with multiple channels using programs such as QUB and HJCFIT. We report this information as an interstate or interchannel transition graph, as shown in (a4). In this graph, the point at location (X,Y) = (2,1) indicates that there is a transition from two simultaneous open channels to one open channel (one of the open channels closed). The size of the circle is proportional to the number of such transitions found in all traces that we processed. Similarly, the point at location (X,Y) = (1,2) indicates that another channel opened between time t and t+δt, and the total number of open channels is now two. We also observed transitions in which the total number of channels at time t and t+δt are not consecutive digits. The dwell-time distributions (first row), mean PO (second row), mean τO (third row), and mean τC (fourth row) when at least one (b1b4), two (c1c4), three (d1d4), and four (e1e4) channels are open in all traces are also shown in Fig. 6. The software saves this information for all channels identified (10 in this case), but the statistics for the remaining six channels are skipped for clarity.

The method also works for fluorescence traces representing the function of ion channels having multiple levels with quantal conductances and traces with very low SNR. As an example, we process fluorescence traces from TIRFM of many Aβ142-induced Ca2+-permeable pores in the PM of Xenopus oocyte and summarize our results in Fig. 7. We observe a closed level in which no Ca2+ flux is passing through the pore (represented by level 0) and up to five open conductance levels (represented by level 1, 2, 3, 4, and 5) (9). In Fig. 7, we show a sample raw trace; the separated background; idealized trace; the distribution of dwell times; mean PO, mean τO, mean τC when the channel is gating in a conductance level equal to or larger than 1, 2, 3, and 4; and the number of transitions between different conductance levels. We skip the distributions for conductance level 5, as there were only a few instances in which the channel opened in that level. The details about the data for Aβ142 pores are similar to that of IP3-induced puffs except that the number of open channels from the puffs discussion is replaced by conducting levels in the case of Aβ142 pores. We would like to point out that there is a significantly larger number of transitions between levels 0 and 1 in comparison to the puffs data, indicating that Aβ142 pores prefer to gate in low conductance levels. Also, in comparison to IP3-induced puffs, we observed a larger number of transitions in which the levels involved are not immediately next to each other (for example, transitions from level 0 to level 2 and vice versa) (Fig. 7 a4).

Figure 7.

Figure 7

Processing fluorescence records from TIRFM of Aβ142-induced pores in the PM of Xenopus oocytes. The first column on the left shows a sample raw trace (black) and the background separated by TraceSpecks (gray) (a1), the corresponding idealized trace representing the conductance level in which the pore is gating (a2), amplitude (the highest conductance level in which the channel is gating during a single opening event) distribution (a3), and the transition between different conductance levels (a4) for all opening and closing events in all traces processed. The remaining four columns show distributions of dwell times (first row), mean PO (second row), mean τO (third row), and mean τC (fourth row) when the pore is gating in level 1 or above (b1b4), level 2 or above (c1c4), level 3 or above (d1d4), and level 4 or above (e1e4) in all traces processed. Mean τC for conductance level i represents the mean time when the conductance level is less than i. To see this figure in color, go online.

Conclusions

Data from fluorescence imaging as well as the routinely employed electrophysiological patch-clamp techniques are contaminated with noise and drifting background that does not arise from the system under study. Removing this noise and fluctuating background is usually the first step in the analysis of the data. In the absence of an automated method, experimentalists adhere to the eye and the mouse-based approach for processing noisy imaging and patch-clamp data. This laborious manual procedure could cost experimentalists more time processing the data than conducting the actual experiment.

One example of where the lack of efficient algorithm for separating the signal from background noise could limit the full utilization of very powerful experimental techniques is the high-resolution imaging of Ca2+ signals. Recent advances in imaging techniques such as TIRFM offer a paradigm-shifting improvement in our ability to study thousands of ion channels in parallel within their native environment (1, 2). This technique, called “optical patch-clamp,” generates fluorescence time traces from thousands of ion channels in a single experiment. Although an algorithm to automatically detect, localize, and measure fluorescence changes during localized Ca2+ signals imaged through optical patch-clamp has been recently developed (41), the lack of efficient algorithms to extract signal out of the noise and idealize the fluorescence traces remains the main hurdle in accessing a wide range of information about the system under investigation and developing single-channel/molecule models based on huge data sets collected from thousands of channels/molecules in their native environment in these experiments.

In this work, we developed a minimally parameterized likelihood method that can process both noisy patch-clamp and imaging data with drifting background. The robustness and accuracy of our algorithm is demonstrated by closely recovering the signal from noisy synthetic patch-clamp data with variable SNR and fluorescence traces representing Ca2+ puffs generated by a cluster of IP3R channels. This was followed by the processing of significant data from both TIRFM experiments as well as patch-clamp recordings and extracting many important features from the data.

We implemented our algorithm in the very portable Java language with options to set up initial parameters; display optimized parameters, raw trace, and separated background; and idealize trace, mean PO, τO, and τC for all channels/conductance levels in the trace as well as the overall mean PO, τO, and τC of the trace (Fig. 1). The option to store all these traces and statistics is also provided in addition to dwell times for the channel gating in different conducting states or different numbers of open channels in a cluster or a patch, amplitude distribution of all events in terms of the highest number of channels open/conductance level and peak fluorescence in which the channel is gating during the event, and the number of transitions between different states in ascii format for plotting and later use. A compiled Java program with a user-friendly GUI that performs all these tasks and that is portable to Mac, personal computer, and Unix platforms with user manual and source code is provided in the online supplement.

As pointed out above, our labs have completed the development of another software program called CellSpecks that can detect and extract fluorescence traces for thousands of channels in a membrane patch recorded simultaneously in their native environment at single-channel and millisecond resolutions using TIRFM. Merging TraceSpecks and CellsSpecks will result in a comprehensive software capable of detecting thousands of channels in a video sequence recorded through high-resolution fluorescence microscopy, idealizing, and analyzing traces from all channels. Developing such a comprehensive software is beyond the scope of this work and will be the subject of our future research.

Author Contributions

S.I.S. performed the research, contributed analytic tools, analyzed the data, and wrote the article. A.D. performed the research, analyzed the data, and wrote the article. D.-O.D.M. performed the research and analyzed the data. I.P. designed the research. J.E.P. designed the research and contributed analytic tools. G.U. designed the research, contributed analytic tools, analyzed the data, and wrote the article.

Acknowledgments

This work was supported by National Institutes of Health through grants R01 AG053988 (to A.D. and G.U.), R01 GM065830 (to D.-O.D.M., I.P., and J.E.P.), and R37 GM048071 (to I.P.).

Editor: James Sneyd.

Footnotes

Supporting Material

Data S1. The Software, User Manual, and Sample Data Sets
mmc1.zip (1MB, zip)
Data S2. Java Source Code for the Software
mmc2.zip (211KB, zip)

References

  • 1.Demuro A., Parker I. Imaging the activity and localization of single voltage-gated Ca2+-channels by total internal reflection fluorescence microscopy. Biophys. J. 2004;86:3250–3259. doi: 10.1016/S0006-3495(04)74373-8. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 2.Demuro A., Parker I. “Optical patch-clamping”: single-channel recording by imaging Ca2+ flux through individual muscle acetylcholine receptor channels. J. Gen. Physiol. 2005;126:179–192. doi: 10.1085/jgp.200509331. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 3.Demuro A., Parker I. Imaging single-channel calcium microdomains by total internal reflection microscopy. Biol. Res. 2004;37:675–679. doi: 10.4067/s0716-97602004000400025. [DOI] [PubMed] [Google Scholar]
  • 4.Demuro A., Parker I. Optical single-channel recording: imaging Ca2+ flux through individual ion channels with high temporal and spatial resolution. J. Biomed. Opt. 2005;10:11002. doi: 10.1117/1.1846074. [DOI] [PubMed] [Google Scholar]
  • 5.Demuro A., Parker I. Imaging single-channel calcium microdomains. Cell Calcium. 2006;40:413–422. doi: 10.1016/j.ceca.2006.08.006. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 6.Smith I.F., Parker I. Imaging the quantal substructure of single IP3R channel activity during Ca2+ puffs in intact mammalian cells. Proc. Natl. Acad. Sci. USA. 2009;106:6404–6409. doi: 10.1073/pnas.0810799106. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 7.Navedo M.F., Santana L.F. CaV1.2 sparklets in heart and vascular smooth muscle. J. Mol. Cell. Cardiol. 2013;58:67–76. doi: 10.1016/j.yjmcc.2012.11.018. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 8.Demuro A., Smith M., Parker I. Single-channel Ca2+ imaging implicates Aβ1-42 amyloid pores associated with Alzheimer’s disease pathology. J. Cell Biol. 2011;195:515–524. doi: 10.1083/jcb.201104133. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 9.Ullah G., Demuro A., Pearson J.E. Analyzing and modeling the kinetics of amyloid beta pores associated with Alzheimer’s disease pathology. PLoS One. 2015;10:e0137357. doi: 10.1371/journal.pone.0137357. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 10.Colquhoun D. Microelectrode Techniques: The Plymouth Workshop Handbook. Company of Biologists; 1987. Practical analysis of single channel records; pp. 101–139. [Google Scholar]
  • 11.Witkoskie J.B., Cao J. Analysis of the entire sequence of a single photon experiment on a flavin protein. J. Phys. Chem. B. 2008;112:5988–5996. doi: 10.1021/jp075980p. [DOI] [PubMed] [Google Scholar]
  • 12.Sachs F. Single-Channel Recording. Springer; 2009. Automated analysis of single-channel records. [Google Scholar]
  • 13.Colquhoun D., Sigworth F. Single-Channel Recording. Springer; 2009. Fitting and statistical analysis of single-channel data. [Google Scholar]
  • 14.Milescu L.S., Yildiz A., Sachs F. Extracting dwell time sequences from processive molecular motor data. Biophys. J. 2006;91:3135–3150. doi: 10.1529/biophysj.105.079517. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 15.Milescu L. SUNY; 2003. Applications of hidden Markov models to single molecule and ensemble data analysis. Ph.D. thesis. [Google Scholar]
  • 16.Hamill O.P., Marty A., Sigworth F.J. Improved patch-clamp techniques for high-resolution current recording from cells and cell-free membrane patches. Pflugers Arch. 1981;391:85–100. doi: 10.1007/BF00656997. [DOI] [PubMed] [Google Scholar]
  • 17.Qin, F., A. Milescu, …, J. Bannen. 2008. QUB. http://www.qub.buffalo.edu.
  • 18.Qin F., Auerbach A., Sachs F. Estimating single-channel kinetic parameters from idealized patch-clamp data containing missed events. Biophys. J. 1996;70:264–280. doi: 10.1016/S0006-3495(96)79568-1. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 19.Colquhoun, D. 2007. HJCFit. http://www.ucl.ac.uk/pharmacology/dcpr95.html#intro.
  • 20.Fisher R. Theory of statistical estimation. Math. Proc. Camb. Philos. Soc. 1925;22:700–725. [Google Scholar]
  • 21.Bruno W.J., Ullah G., Pearson J.E. Automated maximum likelihood separation of signal from baseline in noisy quantal data. Biophys. J. 2013;105:68–79. doi: 10.1016/j.bpj.2013.02.060. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 22.Milescu L., Nicolai C., Sachs F. Hidden Markov model applications in QuB: analysis of nanometer steps in single molecule fluorescence data and ensemble ion channel kinetics. Biophys. J. 2003;84:124A. [Google Scholar]
  • 23.Milescu L.S., Akk G., Sachs F. Maximum likelihood estimation of ion channel kinetics from macroscopic currents. Biophys. J. 2005;88:2494–2515. doi: 10.1529/biophysj.104.053256. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 24.Baum L., Petrie T. Statistical inference for probabilistic functions of finite state Markov chains. Ann. Math. Stat. 1966;37:1554–1563. [Google Scholar]
  • 25.Baum L., Petrie T., Weiss N. A maximization technique occurring in the statistical analysis of probabilistic functions of Markov chains. Ann. Math. Stat. 1970;41:164–171. [Google Scholar]
  • 26.Welch L.R. Hidden Markov models and the Baum-Welch algorithm. IEEE Information Theory Society Newsletter. 2003;53:10–13. [Google Scholar]
  • 27.Dempster A., Laird N., Rubin D. Maximum likelihood from incomplete data via the EM algorithm. J. Roy. Stat. Soc. B. 1977;39:1–38. [Google Scholar]
  • 28.Ullah G., Parker I., Pearson J.E. Multi-scale data-driven modeling and observation of calcium puffs. Cell Calcium. 2012;52:152–160. doi: 10.1016/j.ceca.2012.04.018. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 29.Mak D.O., Pearson J.E., Foskett J.K. Rapid ligand-regulated gating kinetics of single inositol 1,4,5-trisphosphate receptor Ca2+ release channels. EMBO Rep. 2007;8:1044–1051. doi: 10.1038/sj.embor.7401087. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 30.Demuro A., Parker I. Cytotoxicity of intracellular Aβ1-42 amyloid oligomers involves Ca2+ release from the endoplasmic reticulum by stimulated production of inositol trisphosphate. J. Neurosci. 2013;33:3824–3833. doi: 10.1523/JNEUROSCI.4367-12.2013. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 31.Mak D.O., Cheung K.H., Ullah G. Analyzing and quantifying the gain-of-function enhancement of IP3 receptor gating by familial Alzheimer’s disease-causing mutants in Presenilins. PLoS Comput. Biol. 2015;11:e1004529. doi: 10.1371/journal.pcbi.1004529. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 32.Ullah G., Ullah A. Mode switching of Inositol 1,4,5-trisphosphate receptor channel shapes the Spatiotemporal scales of Ca2+ signals. J. Biol. Phys. 2016;42:507–524. doi: 10.1007/s10867-016-9419-2. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 33.Ullah G., Jung P. Modeling the statistics of elementary calcium release events. Biophys. J. 2006;90:3485–3495. doi: 10.1529/biophysj.105.073460. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 34.Shuai J., Parker I. Optical single-channel recording by imaging Ca2+ flux through individual ion channels: theoretical considerations and limits to resolution. Cell Calcium. 2005;37:283–299. doi: 10.1016/j.ceca.2004.10.008. [DOI] [PubMed] [Google Scholar]
  • 35.Toglia P., Ullah G., Pearson J.E. Analyzing optical imaging of Ca2+ signals via TIRF microscopy: the limits on resolution due to chemical rates and depth of the channels. Cell Calcium. 2017;67:65–73. doi: 10.1016/j.ceca.2017.08.010. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 36.Foskett J.K., White C., Mak D.O. Inositol trisphosphate receptor Ca2+ release channels. Physiol. Rev. 2007;87:593–658. doi: 10.1152/physrev.00035.2006. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 37.Mak D., McBride S., Foskett J. Inositol 1,4,5-trisphosphate [correction of tris-phosphate] activation of inositol trisphosphate [correction of tris-phosphate] receptor Ca2+ channel by ligand tuning of Ca2+ inhibition. Proc. Natl. Acad. Sci. USA. 1998;95:15821–15825. doi: 10.1073/pnas.95.26.15821. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 38.Mak D., White C., Foskett J. CRC Press; 2005. Nuclear patch clamp electrophysiology of inositol trisphosphate receptor Ca2+ release channels. In Methods in Calcium Signaling Research; pp. 203–229. [Google Scholar]
  • 39.Lock J.T., Parker I., Smith I.F. A comparison of fluorescent Ca2+ indicators for imaging local Ca2+ signals in cultured cells. Cell Calcium. 2015;58:638–648. doi: 10.1016/j.ceca.2015.10.003. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 40.Mak D.O., Vais H., Foskett J.K. Patch-clamp electrophysiology of intracellular Ca2+ channels. Cold Spring Harb. Protoc. 2013;2013:787–797. doi: 10.1101/pdb.top066217. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 41.Ellefsen K.L., Settle B., Smith I.F. An algorithm for automated detection, localization and measurement of local calcium signals from camera-based imaging. Cell Calcium. 2014;56:147–156. doi: 10.1016/j.ceca.2014.06.003. [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

Data S1. The Software, User Manual, and Sample Data Sets
mmc1.zip (1MB, zip)
Data S2. Java Source Code for the Software
mmc2.zip (211KB, zip)

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

RESOURCES