Open Access
11 April 2014 Monte Carlo simulation of light transport in turbid medium with embedded object—spherical, cylindrical, ellipsoidal, or cuboidal objects embedded within multilayered tissues
Author Affiliations +
Abstract
Monte Carlo modeling of light transport in multilayered tissue (MCML) is modified to incorporate objects of various shapes (sphere, ellipsoid, cylinder, or cuboid) with a refractive-index mismatched boundary. These geometries would be useful for modeling lymph nodes, tumors, blood vessels, capillaries, bones, the head, and other body parts. Mesh-based Monte Carlo (MMC) has also been used to compare the results from the MCML with embedded objects (MCML-EO). Our simulation assumes a realistic tissue model and can also handle the transmission/reflection at the object-tissue boundary due to the mismatch of the refractive index. Simulation of MCML-EO takes a few seconds, whereas MMC takes nearly an hour for the same geometry and optical properties. Contour plots of fluence distribution from MCML-EO and MMC correlate well. This study assists one to decide on the tool to use for modeling light propagation in biological tissue with objects of regular shapes embedded in it. For irregular inhomogeneity in the model (tissue), MMC has to be used. If the embedded objects (inhomogeneity) are of regular geometry (shapes), then MCML-EO is a better option, as simulations like Raman scattering, fluorescent imaging, and optical coherence tomography are currently possible only with MCML.

1.

Introduction

Knowing the light fluence distribution or the amount of light absorbed inside biological tissue is useful in many applications, such as photoacoustic (PA) imaging, diffused optical tomography, Raman scattering, and fluorescence imaging. Monte Carlo (MC) simulation for light propagation in biological medium solves the radiative transfer equation numerically. Therefore, it is considered to be the gold standard for predicting the fluence distribution in biological tissue for many optical imaging modalities. MC for light propagation in biological medium was introduced by Wilson.1 It was modified by many others for usability.24 MC modeling of light transport in multilayered tissues (MCML) coded in standard C, brought to public domain by Wang et al., has been extensively used for various studies.5 Error percentages are higher in MATLAB® ported MCML, but the graphical outputs are easier to obtain.6 Initially, the drawback of MCML was the long time taken for each simulation. As mentioned by Zhu and Liu, with high-end computation facilities available these days, computation time has reduced from many hours to a few minutes.7 Multicanonical MC8 has been introduced, which is a speeded-up form of classical MCML. Moreover, variations of MCML simulations for fluorescence propagation and Raman generation were also reported, which are computationally time demanding.9,10

Another drawback of MCML was its inability to model geometries other than layers. Tissue models with embedded objects have been published for various applications.7 Currently, hybrid models are used for simple geometries, such as skin tumor, where the tumor is considered to be cuboidal.11 Another hybrid, MC and diffusion theory, was developed by Golshan et al. for the study of light propagation in skin.12 MC simulations for photodynamic therapy for tumor assume the embedded object to be of spherical shape.13 For modeling of illumination configuration for light focusing in tissue with blood vessels and capillaries, the embedded object is modeled as cylindrical in shape.14,15 In the above cases, the refractive index of the embedded object is matched with that of the surrounding tissue. In our previous work, the refractive index mismatch was taken into consideration for an embedded sphere for simulation of light delivery configuration of PA imaging of sentinel lymph nodes.16 Modeling of light propagation in a cylinder with embedded cylinder depicting blood vessel and sphere within a sphere depicting head has also been reported, which are specific to applications.1720 MCML was also modified to specify optical properties for each grid instead of an entire layer to model skin.21

Mesh-based MC (MMC) and GPU-based MC by Fang et al. has been used to study light propagation in a rat model and adult/neonatal brain, where the inhomogeneity is of irregular geometry.22,23 Input to MMC is meshes generated either from images (grayscale or binary) or by specifications of geometric dimensions and location. Mesh generation demands expertise in MATLAB® (or Octave) programming. Programs have to be written to decode the output of MMC, which is in the form of vertices, nodes, and faces of meshes. Due to the complexity involved in using MMC in comparison with MCML, tumor is modeled as layer.24 Since the MCML code is readily available, customization, such as Raman scattering, Tyndall effect, and fluorescence imaging, needs lesser efforts and can be done faster. For modeling photon reflectors one has to stick to MCML, as reflecting the photons that are transmitted or reflected at the boundaries is easier in MCML than MMC. To model photon reflector in MMC, the tracked photons that reach the reflection surface have to be remitted once the run is over.9,16 CONV MCML is also readily available if one wants to model broad laser beam rather than pencil beam, whereas MMC is specific to one pencil beam (point source).25 MMC can model regular and irregular geometries, but nonconventional photon tracing, such as Raman fluorescence, is not possible. So there is a need for MCML with the capability of simulating multilayered tissues with embedded objects. The hybrid models are easier to model than MMC, but they reduce accuracy.

In this work, MCML with object of regular geometry (sphere, ellipsoid, cylinder, or cuboid) was embedded in the layered surrounding tissue; we refer to this as MMCL with embedded objects (MCML-EO). The refractive index mismatch between the embedded object and the surrounding tissue is also handled in this simulation. Tumors and lymph nodes can be modeled close to sphere or ellipsoid. Red blood cells are ellipsoidal in shape. Simulation of blood vessels and bone need cylindrical geometry embedded in tissue. For the completeness, modeling of cuboidal geometry is also discussed. The MMC is also run with embedded objects with similar optical properties and dimensions for comparisons.

2.

Simulation Setup

In MCML, photons are traced in the medium with known optical properties, such as absorption coefficient (μa), scattering coefficient (μs), scattering anisotropy (g), and refractive index (n) of the medium. Figure 1 depicts the flow chart of MCML modified for embedded object. Launched photon in MCML takes a random step-size and checks if the layer boundary is hit with this step-size based on the z direction cosine (uz) of the photon. If uz is negative, then the boundary check is for the layer above the photon’s current layer. If uz is positive, then the boundary check is for the layer below the photon’s current layer. If there is no boundary hit, then the photon hops to the next scattering site with the step-size and drops weight based on absorption coefficient of the medium. When the photon hits the boundary, the step-size is recomputed to find the distance between photon’s current location and the boundary. Photon after taking the recomputed step-size moves to the boundary and checks if it has to cross the boundary (transmit) or not (reflection). The decision is governed by Snell’s law based on the refractive indices of the layers across the boundary. The direction cosines of the photon either on reflection or on transmission are updated based on Fresnel formula. Photon’s direction cosines remain unchanged under matched boundary conditions. The photon moves the remaining part of the step-size either in the same layer or in the transmitted layer based on whether the photon is reflected or transmitted. The photons are tracked till they die. A photon’s tracking is terminated when its weight is <106 (variable) using Russian roulette or when it escapes from the simulation geometry into the outer medium (launch surface or transmission surface, typically air or water).

Fig. 1

Modified Monte Carlo modeling of light transport in multilayered tissue (MCML) flow chart for the embedded object. s is the dimensionless step-size, ξ is a random number, db is the distance between current location of the photon and the layer, dob is the distance between current location of the photon and the object, and μt is the total interaction coefficient.

JBO_19_4_045003_f001.png

For embedded objects there are two challenges: one is computing the distance of the photon from the scattering site to the object boundary and the other is determining the direction cosine of the photon after it is reflected/transmitted at the object boundary. Both the problems arise due to the curved nature of the sphere, cylinder, and ellipsoid object.26 In case of cuboid, the calculation of the distance to the boundary is much simpler, and it is explained in the original MCML for layers.5 We used the same method here as well for the embedded cuboid. The rest of the section explains how to find out the distance between the photon’s current position and the boundary of the object (sphere, ellipsoid, and cylinder), and whether the photon is going to hit the boundary with the step-size it needs to travel.

Equation of an origin-shifted sphere centered at C(Cx,Cy,Cz) with radius r is

Eq. (1)

(xCx)2+(yCy)2+(zCz)2=r2.

Equation of an origin-shifted cylinder aligned along the axis vector (1,0,0), centered at C(Cx,Cy,Cz) with radius r is

Eq. (2)

(yCy)2+(zCz)2=r2.

Equation of an origin-shifted ellipsoid centered at C(Cx,Cy,Cz) with radius along x, y, and z axis as (rx,ry,rz) is

Eq. (3)

(xCx)2rx2+(yCy)2ry2+(zCz)2rz2=1.

A ray of origin (Ox,Oy,Oz) with direction cosines d(dx,dy,dz) parameterized by distance t is represented by the equation (O+td), where “∘” implies multiplication of scalar t with every element in vector d. Any point on the ray at distance t from origin of ray is given by [(Ox+t*dx),(Oy+t*dy),(Oz+t*dz)]. The intersection point between the ray and the curve object has to satisfy the equation of ray and the equation of curved object. Conversely, the ray would intersect with a curved object, if the solution to the quadratic equation in t [Eq. (4)] is real. The quadratic equation is obtained by substituting the ray equation (O+td) in the equation of sphere, cylinder, and ellipsoid, which are quadratic equations themselves [as seen in Eqs. (1) to (3)]. In Eq. (4), t is the distance the ray has to travel to hit the curved object. Numerical values I, J, and K are the coefficients of the equation, which vary for the three geometries. Equation (4) is given as

Eq. (4)

I·t2+J·t+K=0,
where (·) is the multiplication of numerical values with variable t to solve the quadratic equation.

In case of a sphere

Eq. (5a)

I=dx2+dy2+dz2,

Eq. (6)

J=2*(dx*delx+dy*dely+dz*delz),

Eq. (7)

K=delx2+dely2+delz2r2,
where delx=(OxCx), dely=(OyCy), and delz=(OzCz).

In case of a cylinder aligned along axis v(vx,vy,vz)=(1,0,0) (in our case)

Eq. (8)

letdc=dx*vx+dy*vy+dz*vz,

Eq. (9)

ex=dc*vx,ey=dc*vy,andez=dc*vz

Eq. (10)

delx=(OxCx),dely=(OyCy),delz=(OzCz)

Eq. (11)

f=delx*vx+dely*vy+delz*vz

Eq. (12)

gx=(delxf*vx),gy=(delyf*vy),andgz=(delzf*vz)

Eq. (13)

I=ex2+ey2+ez2,

Eq. (14)

J=2*(ex*gx+ey*gy+ez*gz),

Eq. (15)

K=gx2+gy2+gz2r2.

In case of an ellipsoid

delx=(OxCx),dely=(OyCy),delz=(OzCz)

Eq. (16)

I=(dxrx)2+(dyry)2+(dzrz)2,

Eq. (17)

J=(2*delx*dx)rx2+(2*dely*dy)ry2+(2*delz*dz)rz2,

Eq. (18)

K=(delxrx)2+(delyry)2+(delzrz)21.

In all the equations (*) denotes the multiplication of two numbers. If (J24*I*K)>0, then the ray does not intersect the curved object. In that case, there is no hit. Since there are two solutions to the quadratic equation, there are two points of intersection. The distance between the points of intersection O+td and origin of ray O is computed. If the distance is greater than step-size, there is a boundary hit.

Once the photon reaches the boundary, it will undergo either reflection or transmission. For layer interface it is easier to find the normal to the tangential plane. In case of layer, the normal to tangent plane coincides with the global z axis. However, in case of curved geometry, the normal to tangent plane (normal to the incident plane in case of cuboid) does not coincide with the global coordinate z axis; therefore, it needs to be transformed into a local coordinate system whose z axis matches with the normal to tangent. Hence, reflection/transmission is done in local coordinate system and then converted back to the global coordinate just as it is done for spinning of photon in MCML. For a photon of polar and azimuthal angles (θ0,ϕ0), the steps involved in conversion of global coordinate system (ux,uy,uz) to local system (ux,uy,uz) are as follows:

  • 1. Rotate (ux,uy,uz) about z for ϕ0 to get intermediate coordinates (ux,uy,uz).

  • 2. Rotate (ux,uy,uz) about uy for θ0 to get (ux,uy,uz).

The formulation for the above concept is

Eq. (19)

ux=sinθ0*ux*uz*cosϕ0uy*sinϕ0+ux*cosθ01uz2,

Eq. (20)

uy=sinθ0*uy*uz*cosϕ0ux*sinϕ0+uy*cosθ01uz2,

Eq. (21)

uz=1uz2*sinθ0*cosϕ0+uz*cosθ0.

If uz1, then ux=sinθ0*cosϕ0, uy=sinθ0*sinϕ0, and uz=sgn(uz)*cosθ0, where

sgn(uz)={1,ifuz01,otherwise.

The normal to the tangential plane is needed for Fresnel computations. Angle of incidence (i) is cos1|uz|. When there is a refractive index match, angle of transmittance (t) is equal to (i). In case of refractive index mismatch, Snell’s law [Eq. (9)] is used to compute (t).

Eq. (22)

ni*sini=nt*sint,
where ni and nt are the refractive indices of the medium of incidence and medium of transmittance. If ni>nt and i greater than the critical angle sin1(ni/nt), probability of reflection Ri(i) is unity. Otherwise, Fresnel’s formula [Eq. (10)] for unpolarized light determines the percentage of photon being reflected and the rest is transmitted.

Eq. (23)

Ri(i)=sin2(it)sin2(i+t)+tan2(it)tan2(i+t)2.

During transmission, the direction cosines of the photon are updated to [ux*(ni/nt),uy*(ni/nt),sgn(uz)*cost]. For reflection, only uz of the photon is negated.

Figures 2(a) and 2(b) give a few examples of ray interaction at layer boundaries; line MN is the normal to the plane of incidence PQ. MN is parallel to z axis since plane of incidence is perpendicular to it.

  • 1. When the photon is incident on surrounding tissue from launch medium (1.0<1.4) at an angle of 30 deg (ray AB), the whole photon is transmitted into the tissue at 20.9 deg (ray BC) based on Snell’s law [Eq. (9)].

  • 2. When the photon is incident on the transmission medium at 30 deg (ray DE), 3.6% of the photon is reflected (ray EF) and 96.4% is transmitted (ray EG) based on Fresnel formula [Eq. (10)].

  • 3. Since the critical angle [sin1(1.0/1.4)] at transmission boundary is 45.427 when the incident angle is 60 deg (ray HI), the photon is totally internally reflected (ray IJ) as Ri is unity.

  • 4. For a matched boundary scenario, the angle of transmittance (∟CBN) is equal to angle of incidence (∟ABM).

Fig. 2

Examples of ray boundary interaction under matched and mismatched boundary conditions. (a) Reflection and transmission under mismatched boundary condition for rays AB, DE, and HI, which are incident at 30, 30, and 60 deg. (b) Matched boundary condition for ray AB. MN is the normal and PQ is the plane of incidence.

JBO_19_4_045003_f002.png

This section will explain how the normal to the tangential plane is computed in case of curved objects (sphere, ellipsoid, and cylinder) as this is the reference to compute critical angle and transmittance angle. In case of sphere, the line joining the center of the sphere to the point of tangency P(Px,Py,Pz) on the surface [(PxCx),(PyCy),(PzCz)] is the line normal to the tangential plane. This is pictorially represented in Fig. 3(a). A local Cartesian coordinate system is created with the normal line (line perpendicular to the tangential plane) as z axis. The direction cosines are calculated in the rotated coordinate system; angle of reflectance or transmittance is then computed and again converted back to global coordinate system. For an x-axis aligned cylinder, the normal line to a tangent at a point P(Px,Py,Pz) on surface is (0,PyCy,PzCz) [Fig. 3(b)]. For an origin-shifted ellipsoid [Fig. 3(c)], the normal to the tangent at a point P is {[(PxCx)/rx2],[(PyCy)/ry2],[(PzCz)/rz2]). Equation of tangential plane for ellipsoid was derived from Eq. (3) to find its normal.

Fig. 3

Pictorial representation of incidence plane and normal plane considered in executing Fresnel formula for MCML with embedded objects (MCML-EO). Point C is the center of the object and P is the point on the surface of object where the photon reaches when it hits the object boundary. (a) Sphere with tangent (tangential plane in case of three dimension) and normal N, (b) cylinder with tangent and normal, (c) ellipsoid, and (d) cuboid depicting two cases—positive x axis (P1) and positive z axis (P2) being the planes on which photon has reached.

JBO_19_4_045003_f003.png

Now looking into cuboid, which is a collection of six planes, based on the direction cosines of the photon, the boundary check is done for the planes that lie in these directions. Cuboid center (Cx,Cy,Cz) and dimensions [length (lt) along x axis, breath (bt) along y axis, and height (ht) along z axis] are read from the input file. The six planes are defined as follows:

  • Plane on negative Xaxis=(lt/2)+Cx,

  • Plane on negative Yaxis=(bt/2)+Cy,

  • Plane on Zaxis(above center)=(ht/2)+Cz,

  • Plane on positive Xaxis=(lt/2)+Cx,

  • Plane on positive Yaxis=(bt/2)+Cy,

  • Plane on Zaxis(below center)=(ht/2)+Cz.

When uz is positive, the plane below the center of cuboid is checked. When uz is negative, distance computation is with respect to the plane above the center. Sign of ux and uy decide if the distance check should be for the plane on positive axis or negative axis. Reflectance angle and transmittance angle are calculated with respect to the x, y, and z axis based on the plane that the ray intersects. This is shown in Fig. 3(d).

MCML-EO for sphere, ellipsoid, and cuboid was filled with methylene blue for demonstration, as sphere/ellipsoid filled with methylene blue can be used to model the sentinel lymph nodes in PA imaging. Embedded cylinder of radius 0.25 cm was assumed to have properties of blood, which can be used as the model for blood vessels. The dimensions and the optical properties for the embedded objects and the surrounding tissue are given in Tables 1 and 2, respectively. For all the layers and embedded objects, g=0.9. The outer medium (launch surface and transmit surface) was taken as air with refractive index 1.0. The depth of the surrounding tissue layer was taken as 6 cm. Simulation geometry for the four embedded objects are given in Fig. 4. A pencil beam light was launched at the origin (0,0,0) along the z axis with direction cosines (0,0,1). Weight dropped was accumulated in x, y, and z grids. For fluence map, weight dropped was divided by absorption coefficient. Number of grids in each axis is 301 and the size of the grid was 0.02 cm. The volume spanned is 3 to +3cm in x and y axis. Grid covers 0 to 6 cm in z axis. For display (either absorbance map or fluence map) y=0 plane is presented. Contour plot of the fluence (averaged over five grids) is for 5-dB spacing. The geometries with same optical properties and dimensions (approximately) are modeled using MMC for comparison.

Table 1

Dimensions, location, and optical properties of the embedded objects for Monte Carlo modeling of light transport in multilayered tissue with embedded objects (MCML-EO) and mesh-based Monte Carlo (MMC).

Embedded objectDepth (cm)Dimension required as input parameterDimension (cm)Contains
Sphere1.2Radius0.5Methylene blue
Cylinder1.2Radius, axis0.25 [1 0 0]Blood
Ellipsoid1.2Radius in three axis[1.0 0.8 0.5]Methylene blue
Cuboid1.2[length width height][1.4 1.2 1.0]Methylene blue

Table 2

Optical properties of various layers used in the MCML-EO and MMC simulation model at 664-nm wavelength.

Optical properties of mediumRefractive index (n)Absorption coefficient of medium μa (cm1)Scattering coefficient of medium μs (cm1)Scattering anisotropy (g)
Surrounding tissue1.40.25252540.9
Methylene blue (concentration 10 μM)1.31.70491800.9
Blood1.352.107730.9
Air1.0

Fig. 4

Schematic diagram of the simulation geometry. Skin of semi-infinite depth with n=1.4, μa=0.2525cm1, and μs=254cm1. (a) 1-cm diameter spherical object placed 0.7 cm below the skin filled with methylene blue of n=1.3, μa=1.7049cm1, and μs=180cm1. (b) 0.5-cm diameter cylinder placed 0.95 cm below the skin filled with blood of n=1.35, μa=2.10cm1, and μs=773cm1. (c) 1-cm diameter along z axis ellipsoidal object placed 0.7 cm below the skin filled with methylene blue. (d) 1-cm (height) cuboid placed 0.7 cm below the skin filled with methylene blue. g=0.9 for all the layers and objects. Inputs are in cm1 for MCML-EO and in mm1 for mesh-based Monte Carlo (MMC).

JBO_19_4_045003_f004.png

MMC mex files along with preprocessing and postprocessing MATLAB® functions were downloaded and compiled from website.27 Ray tracing using Plücker co-ordinate system was implemented to trace photons in nonhomogeneous medium. In MCML-EO the surrounding medium was infinite along x and y axis. Simulating infinite medium in MMC is not possible; thus, in MMC, the objects were embedded into a relatively large box of dimension 20×20×6cm (which can be assumed approximately infinite compared to the inclusion dimension). All inputs are in millimeters in MMC. The maximum volume for a single mesh was 0.020 cm3. The incident light beam is a point source (pencil beam) illuminating at (10.1,10.1,0) with the incident direction cosine (0,0,1). Optical properties of the surrounding tissue (box) is μa=0.2525cm1, μs=254cm1, and n=1.3 at 664-nm wavelength.28 The optical properties of methylene blue (of concentration 10 μM) are μa=1.7049cm1 and μs=180cm1.29,30 Optical properties of whole blood are μa=2.10cm1, μs=773cm1, and n=1.4.31,32 All simulations were run for 106 photons on a desktop with Intel i7 64-bit processor and 8 Gb RAM. Plane y=100 is imaged and contoured with 10-dB spacing.

3.

Results and Discussion

The major drawback of MCML of not being able to handle boundaries other than layers is addressed to increase the flexibility of the simulation tool. The contribution of the work is consolidation of distance calculation to the curved boundaries of sphere, cylinder, and ellipsoid and computation of tangential plane and its normal for execution of Fresnel formula. MCML modified for embedded objects is compared with MMC in terms of fluence map. First, MCML-EO simulations were run for all four types of embedded objects, considering both boundary refractive-index matched and mismatched conditions between the embedded object and the surrounding tissue. Table 3 shows the absorption inside the embedded object for four cases. As observed, the difference in absorbance (error) within the object ranges from 4 to 6% between refractive-index matched and mismatched cases. Absorbance within the embedded object ranges from 0.03 to 0.007. Note that the absorption is more when there is refractive-index matched boundary (which is not a practical scenario) compared with mismatched boundary condition. Absorption of light within embedded object is of interest in many applications; for example, in case of sentinel lymph node detection, one needs to optimize the total absorbance inside the node to achieve high signal-to-noise ratio.16

Table 3

Absorbance within the embedded object under matched and mismatched boundary conditions.

Embedded objectAbsorption inside the objectPercentage of error (%)
Matched boundaryMismatched boundary
Sphere0.0099690.0094265.76
Cylinder0.0081410.007824.10
Ellipsoid0.017310.016385.68
Cuboid0.034000.035785.23

Figure 5 shows the absorbance map (in log scale) of the four MCML-EO simulations. The dotted black lines represent the boundary of the embedded object. Figures 5(a) to 5(d) show absorbance along y=0 plane in case of sphere, cylinder, ellipsoid, and cuboid, respectively. Number of pixels (grids) along x and z axis are 300 each. Absorption map is important to study effects of illumination during phototherapy.14 Once again, one can play with the light delivery configuration, optical properties, and various object sizes to see what kind of absorption map one wants to achieve. This makes MCML-EO a very flexible tool for various clinical uses.

Fig. 5

Absorption map from Monte Carlo for turbid medium with embedded object along y=0 plane. (a) to (d) Sphere, cylinder, ellipsoid, and cuboid. Black dotted lines are boundaries of the embedded object.

JBO_19_4_045003_f005.png

Figure 6 shows the log of fluence map from MCML-EO and MMC. Figures 6(a) to 6(d) show the fluence map from MCML-EO, where each pixel is 0.2 mm and the number of pixels is 300×300. Figures 6(e) to 6(h) are the fluence maps from MMC, which cover the meshes from 7 to 13 cm. Log of fluence distribution is represented in the color bar. The contours of the fluence distribution from MMC and MCML-EO are shown in Figs. 6(i) to 6(l). MCML-EO contours are smoother compared to that of MMC, probably due to the much finer grids in MCML-EO compared to the meshes in MMC. Again, the dotted black lines are the boundaries for the object embedded. We can see agreement between MMC and MCML-EO. The simulation parameters do not exactly match in both MMC and MCML-EO as mentioned earlier. MCML-EO is for semi-infinite medium, whereas MMC is done for bounded medium (large compared to the embedded object size). But for qualitative comparison, it is acceptable.

Fig. 6

Fluence map of MCML-EO (y=0 plane) and MMC (y=100 plane) along with contours. (a) to (d) Fluence map of sphere, cylinder, ellipsoid, and cuboid from MCML-EO. (e) to (h) Fluence map of sphere, cylinder, ellipsoid, and cuboid from MMC. (i) to (l) Contours of fluence distribution of sphere, cylinder, ellipsoid, and cuboid from MCML-EO (5 dB line spacing) and MMC (10 dB line spacing).

JBO_19_4_045003_f006.png

Average runtime for MCML-EO is 4 min per geometry. Average runtime for MMC per geometry is 15min. There are a few seconds (40 s) spent in mesh generation in case of MMC, but MCML-EO needs no preprocessing. In applications where the interest is to know total absorbance in the embedded object (as is the case in illumination configuration for PA imaging of sentinel lymph node16), there is no postprocessing involved for MCML-EO as the weight dropped in the embedded object is accumulated and printed in the output file. But MMC requires postprocessing to track the weights dropped in the meshes contributing to the embedded object. For the fluence or absorption maps seen in Figs. 5 and 6(a) to 6(d), the postprocessing time goes up to 15 min in MCML-EO, but it takes only few seconds (45 s) in the case of MMC. With the increase in the volume of interest, the mesh generation time also increases. With increased mesh counts, the computation requires higher memory and increased CPU speed. The flexibility of MMC is that the number of meshes can be more for the embedded object and sparse in the tissue.

In case of finer inhomogeneity, such as brain modeling, one has to proceed with MMC, where the simulation geometry is given as volumetric data in the form of images. MCML-EO is 200times faster than MMC with respect to run time; however, embedding complex geometries will be a challenge in MCML. Optical properties can be assigned on nodal basis, which increases accuracy of modeling in the case of MMC. But for simpler modeling, such as blood vessels (cylinder), lymph nodes (ellipsoid), tumor (sphere), bone, and capillaries, one can use the MCML-EO.

4.

Conclusion

MCML-EO of geometries like sphere, cylinder, ellipsoid, and cuboid increases the flexibility of MCML for simulating more realistic structures of biological systems. Raman modeling, effect of photon reflectors, and distributed illumination sources can be easily studied for geometries other than layers. Total computation times for both MCML-EO and MMC are approximately the same. However, larger geometries need more memory for generating meshes in the case of MMC. From the programming language point of view, MMC requires knowledge of MATLAB®/Octave (for three-dimensional pre- and postprocessing). In MCML-EO outputs are either matrices (diffused reflectance, transmittance, and absorbance) or variable (absorption within embedded object). Standard C version of MCML code is available online, so remodeling it is easier compared to MMC, where preprocessing and postprocessing files are in MATLAB® and only mex files of MC are available. In this work we have considered refractive index mismatch between the embedded object and the surrounding medium. Both MCML-EO and MMC are capable of producing similar fluence map and absorption map. It is also seen that if boundary refractive index mismatch is ignored, 4 to 6% error is recorded in the total absorption within the embedded object. Future work is to combine MCML for all regular geometries, which would make it a more user-friendly tool, such as Online Monte Carlo, GNEAT.33,34 Having discussed MCML-EO and MMC, the users can choose the tool that best suits their requirement. If one is interested in irregular geometry, then MMC should be the choice. Embedded object of defined geometry within a bounded medium can be simulated using MMC and MCML-EO. If the application requires nonconventional photon tracking, such as reflector design, Raman propagation, and fluorescence, then MCML-EO would be an apt choice.

Acknowledgments

The author would like to thank Dr. Qianqian Fang, assistant professor in radiology, of Martinos Center for Biomedical Imaging, Massachusetts General Hospital, Harvard Medical School, for his help in understanding and implementing mesh-based Monte Carlo.

References

1. 

B. C. Wilson, “A Monte Carlo model for the absorption and flux distributions of light in tissue,” Med. Phys., 10 (6), 824 (1983). http://dx.doi.org/10.1118/1.595361 MPHYA6 0094-2405 Google Scholar

2. 

S. A. Prahlet al., “A Monte Carlo model of light propagation in tissue,” Proc. SPIE, IS 5 102 –111 (1989). PSISDG 0277-786X Google Scholar

3. 

S. T. Flocket al., “Monte Carlo modeling of light propagation in highly scattering tissue—I: Model predictions and comparison with diffusion theory,” IEEE Trans. Biomed. Eng., 36 (12), 1162 –1168 (1989). http://dx.doi.org/10.1109/TBME.1989.1173624 IEBEAX 0018-9294 Google Scholar

4. 

C. J. HourdakisA. Perris, “A Monte Carlo estimation of tissue optical properties for use in laser dosimetry,” Phys. Med. Biol., 40 (3), 351 –364 (1995). http://dx.doi.org/10.1088/0031-9155/40/3/002 PHMBA7 0031-9155 Google Scholar

5. 

L. H. V. WangS. L. JacquesL. Zheng, “MCML—Monte Carlo modelling of light transport in multi-layered tissues,” Comput. Methods Programs Biomed., 47 (2), 131 –146 (1995). http://dx.doi.org/10.1016/0169-2607(95)01640-F CMPBEK 0169-2607 Google Scholar

6. 

M. AtifA. KhanM. Ikram, “Modeling of light propagation in turbid medium using Monte Carlo simulation technique,” Opt. Spectrosc., 111 (1), 107 –112 (2011). http://dx.doi.org/10.1134/S0030400X11070022 OPSUA3 0030-400X Google Scholar

7. 

C. ZhuQ. Liu, “Review of Monte Carlo modeling of light transport in tissues,” J. Biomed. Opt., 18 (5), 050902 (2013). http://dx.doi.org/10.1117/1.JBO.18.5.050902 JBOPFO 1083-3668 Google Scholar

8. 

A. Bilencaet al., “Multicanonical Monte-Carlo simulations of light propagation in biological media,” Opt. Express, 13 (24), 9822 –9833 (2005). http://dx.doi.org/10.1364/OPEX.13.009822 OPEXFF 1094-4087 Google Scholar

9. 

A. J. Welchet al., “Propagation of fluorescent light,” Lasers Surg. Med., 21 (2), 1997 –1999 (1997). http://dx.doi.org/10.1002/(ISSN)1096-9101 LSMEDI 0196-8092 Google Scholar

10. 

P. Matouseket al., “Dependence of signal on depth in transmission Raman spectroscopy,” Appl. Spectrosc., 65 (7), 724 –733 (2011). http://dx.doi.org/10.1366/11-06259 APSPA4 0003-7028 Google Scholar

11. 

C. ZhuQ. Liu, “Hybrid method for fast Monte Carlo simulation of diffuse reflectance from a multilayered tissue model with tumor-like heterogeneities,” J. Biomed. Opt., 17 (1), 010501 (2012). http://dx.doi.org/10.1117/1.JBO.17.1.010501 JBOPFO 1083-3668 Google Scholar

12. 

M. A. GolshanM. G. TareiA. Amjadi, “The propagation of laser light in skin by Monte Carlo diffusion method: a fast and accurate method to simulate photon migration in biological Ttissues,” J. Lasers Med. Sci., 2 (3), 109 –114 (2011). LMSCEZ 1435-604X Google Scholar

13. 

L. V. WangR. E. NordquistW. R. Chen, “Optimal beam size for light delivery to absorption-enhanced tumors buried in biological tissues and effect of multiple-beam delivery: a Monte Carlo study,” Appl. Opt., 36 (31), 8286 –8291 (1997). http://dx.doi.org/10.1364/AO.36.008286 APOPAI 0003-6935 Google Scholar

14. 

L. V. WangG. Liang, “Absorption distribution of an optical beam focused into a turbid medium,” Appl. Opt., 38 (22), 4951 –4958 (1999). http://dx.doi.org/10.1364/AO.38.004951 APOPAI 0003-6935 Google Scholar

15. 

D. J. SmithiesP. H. Butler, “Modeling the distribution of laser-light in port-wine stains with the Monte-Carlo method,” Phys. Med. Biol., 40 (5), 701 –731 (1995). http://dx.doi.org/10.1088/0031-9155/40/5/001 PHMBA7 0031-9155 Google Scholar

16. 

V. PeriyasamyM. Pramanik, “Monte Carlo simulation of light transport in tissue for optimizing light delivery in photoacoustic imaging of the sentinel lymph node,” J. Biomed. Opt., 18 (10), 106008 (2013). http://dx.doi.org/10.1117/1.JBO.18.10.106008 JBOPFO 1083-3668 Google Scholar

17. 

L. Zhanget al., “Monte Carlo simulation for the light propagation in two-layered cylindrical biological tissues,” J. Mod. Opt., 54 (10), 1395 –1405 (2007). http://dx.doi.org/10.1080/09500340601109289 JMOPEW 0950-0340 Google Scholar

18. 

M. Hiraokaet al., “A Monte Carlo investigation of optical pathlength in inhomogeneous tissue and its application to near-infrared spectroscopy,” Phys. Med. Biol., 38 (12), 1859 –1876 (1993). http://dx.doi.org/10.1088/0031-9155/38/12/011 PHMBA7 0031-9155 Google Scholar

19. 

Y. FukuiY. AjichiE. Okada, “Monte Carlo prediction of near-infrared light propagation in realistic adult and neonatal head models,” Appl. Opt., 42 (16), 2881 –2887 (2003). http://dx.doi.org/10.1364/AO.42.002881 APOPAI 0003-6935 Google Scholar

20. 

D. Ruhet al., “Radiative transport in large arteries,” Biomed. Opt. Express, 5 (1), 54 (2014). http://dx.doi.org/10.1364/BOE.5.000054 BOEICL 2156-7085 Google Scholar

21. 

T. J. Pfeferet al., “A three-dimensional modular adaptable grid numerical model for light propagation during laser irradiation of skin tissue,” IEEE J. Sel. Topics Quantum Electron., 2 (4), 934 –942 (1996). http://dx.doi.org/10.1109/2944.577318 IJSQEN 1077-260X Google Scholar

22. 

Q. Q. Fang, “Mesh-based Monte Carlo method using fast ray-tracing in Plücker coordinates,” Biomed. Opt. Express, 1 (1), 165 –175 (2010). http://dx.doi.org/10.1364/BOE.1.000165 BOEICL 2156-7085 Google Scholar

23. 

Q. Q. FangD. A. Boas, “Monte Carlo simulation of photon migration in 3D turbid media accelerated by graphics processing units,” Opt. Express, 17 (22), 20178 –20190 (2009). http://dx.doi.org/10.1364/OE.17.020178 OPEXFF 1094-4087 Google Scholar

24. 

M. D. Kelleret al., “Monte Carlo model of spatially offset Raman spectroscopy for breast tumor margin analysis,” Appl. Spectrosc., 64 (6), 607 –614 (2010). http://dx.doi.org/10.1366/000370210791414407 APSPA4 0003-7028 Google Scholar

25. 

L. H. V. WangS. L. JacquesL. Zheng, “CONV—convolution for responses to a finite diameter photon beam incident on multi-layered tissues,” Comput. Methods Programs Biomed., 54 (3), 141 –150 (1997). http://dx.doi.org/10.1016/S0169-2607(97)00021-7 CMPBEK 0169-2607 Google Scholar

26. 

M. L. Khanna, Solid Geometry: Co-ordinate Geometry of Three Dimensions, 17th ed.Jai PrakashNath Publications, Meerut (1987). Google Scholar

27. 

Q. Q. Fang, “Monte Carlo eXtreme: GPU-based Monte Carlo Simulations: MMC,” (2014) http://mcx.sourceforge.net/cgi-bin/index.cgi?MMC May ). 2014). Google Scholar

28. 

C. R. Simpsonet al., “Near-infrared optical properties of ex vivo human skin and subcutaneous tissues measured using the Monte Carlo inversion technique,” Phys. Med. Biol., 43 (9), 2465 –2478 (1998). http://dx.doi.org/10.1088/0031-9155/43/9/003 PHMBA7 0031-9155 Google Scholar

29. 

S. Prahl, “Tabulated molar extinction coefficient for methylene blue in water,” (1998) http://omlc.ogi.edu/spectra/mb/mb-water.html March ). 1998). Google Scholar

30. 

S. Fantiniet al., “Absolute measurement of absorption and scattering coefficients spectra of a multiply scattering medium,” Proc. SPIE, 2131 356 –364 (1994). http://dx.doi.org/10.1117/12.180732 PSISDG 0277-786X Google Scholar

31. 

D. K. SardarL. B. Levy, “Optical properties of whole blood,” Lasers Med. Sci., 13 (2), 106 –111 (1998). http://dx.doi.org/10.1007/s101030050062 LMSCEZ 1435-604X Google Scholar

32. 

M. Friebelet al., “Optical properties of circulating human blood in the wavelength range 400–2500 nm,” J. Biomed. Opt., 4 (1), 36 –46 (1999). http://dx.doi.org/10.1117/1.429919 JBOPFO 1083-3668 Google Scholar

33. 

A. DoroninI. Meglinski, “Online object oriented Monte Carlo computational tool for the needs of biomedical optics,” Biomed. Opt. Express, 2 (9), 2461 –2469 (2011). http://dx.doi.org/10.1364/BOE.2.002461 BOEICL 2156-7085 Google Scholar

34. 

A. K. Glaseret al., “A GAMOS plug-in for GEANT4 based Monte Carlo simulation of radiation-induced light transport in biological media,” Biomed. Opt. Express, 4 (5), 741 –759 (2013). http://dx.doi.org/10.1364/BOE.4.000741 BOEICL 2156-7085 Google Scholar

Biography

Vijitha Periyasamy is junior research fellow in electrical engineering at the Indian Institute of Science, Bangalore, India. She has a bachelor’s degree in medical electronics from Visvesvaraya Technological University. Her research interests include biomedical image processing for clinical evaluation, development of multimodal imaging systems, Monte Carlo simulation for light transport in biological tissue, and application of bioengineering for different medical practice systems.

Manojit Pramanik is an assistant professor of bioengineering at Nanyang Technological University, Singapore. He received his PhD in biomedical engineering from Washington University in St. Louis. His research interests include development of photoacoustic/thermoacoustic imaging systems, image reconstruction method, clinical application areas such as breast cancer imaging, molecular imaging, contrast agent development, light transport through biological tissue, Monte-Carlo simulation of light propagation in biological tissue, and Monte-Carlo simulation of Raman scattering.

© 2014 Society of Photo-Optical Instrumentation Engineers (SPIE) 0091-3286/2014/$25.00 © 2014 SPIE
Vijitha Periyasamy and Manojit Pramanik "Monte Carlo simulation of light transport in turbid medium with embedded object—spherical, cylindrical, ellipsoidal, or cuboidal objects embedded within multilayered tissues," Journal of Biomedical Optics 19(4), 045003 (11 April 2014). https://doi.org/10.1117/1.JBO.19.4.045003
Published: 11 April 2014
Lens.org Logo
CITATIONS
Cited by 39 scholarly publications.
Advertisement
Advertisement
RIGHTS & PERMISSIONS
Get copyright permission  Get copyright permission on Copyright Marketplace
KEYWORDS
Monte Carlo methods

Tissues

Optical spheres

Absorption

Optical properties

Refractive index

Multilayers

RELATED CONTENT


Back to Top