Abstract
Purpose
To describe Acuros® CTS, a new software tool for rapidly and accurately estimating scatter in x-ray projection images by deterministically solving the linear Boltzmann transport equation (LBTE).
Methods
The LBTE describes the behavior of particles as they interact with an object across spatial, energy, and directional (propagation) domains. Acuros CTS deterministically solves the LBTE by modeling photon transport associated with an x-ray projection in three main steps: 1) Ray tracing photons from the x-ray source into the object where they experience their first scattering event and form scattering sources. 2) Propagating photons from their first scattering sources across the object in all directions to form second scattering sources, then repeating this process until all high order scattering sources are computed by using the Source Iteration method. 3) Ray tracing photons from scattering sources within the object to the detector, accounting for the detector’s energy and anti-scatter grid responses.
To make this process computationally tractable, a combination of analytical and discrete methods is applied. The three domains are discretized using the Linear Discontinuous Finite Elements, Multigroup, and Discrete Ordinates methods, respectively, which confer the ability to maintain the accuracy of a continuous solution. Furthermore, through implementation in CUDA, we sought to exploit the parallel computing capabilities of graphics processing units (GPUs) to achieve the speeds required for clinical utilization.
Acuros CTS was validated against Geant4 Monte Carlo simulations using two digital phantoms: 1) a water phantom containing lung, air, and bone inserts (WLAB phantom) and 2) a pelvis phantom derived from a clinical CT data set. For these studies, we modeled the TrueBeam® (Varian Medical Systems, Palo Alto, CA) kV imaging system with a source energy of 125kVp. The imager comprised a 600 μm-thick Cesium Iodide (CsI) scintillator and a 10:1 one-dimensional anti-scatter grid. For the WLAB studies, the full-fan geometry without a bowtie filter was used (with and without the anti-scatter grid). For the pelvis phantom studies, a half-fan geometry with bowtie was used (with the anti-scatter grid). Scattered and primary photon fluences and energies deposited in the detector were recorded.
Results
The Acuros CTS and Monte Carlo results demonstrated excellent agreement. For the WLAB studies, the average percent difference between the Monte Carlo- and Acuros-generated scattered photon fluences at the face of the detector was −0.7%. After including the detector response, the average percent differences between the Monte Carlo- and Acuros- generated scatter fractions (SF) were −0.1% without the grid and 0.6% with the grid. For the digital pelvis simulation, the Monte Carlo- and Acuros-generated SFs agreed to within 0.1% on average, despite the scatter-to-primary ratios (SPRs) being as high as 5.5. The Acuros CTS computation time for each scatter image was ~1 second using a single GPU.
Conclusions
Acuros CTS enables a fast and accurate calculation of scatter images by deterministically solving the LBTE thus offering a computationally attractive alternative to Monte Carlo methods. Part II describes the application of Acuros CTS to scatter correction of CBCT scans on the TrueBeam system.
I. INTRODUCTION
Cone-beam CT (CBCT) has proven to be an invaluable clinical tool in the areas of radiotherapy, interventional procedures, and dentistry [1]–[3]. The acquisition of extensive volumetric data in a single rotation is made possible by a wide-area detector such as an amorphous silicon flat-panel imager. However, the wide-area beam generates a large amount of scatter in the projection images, which remains one of the main challenges to achieving high-quality CBCT images [4], [5]. If scatter is not accounted for, reconstructed images can suffer from cupping, shading, streaks, inhomogeneities, and quantification inaccuracies [6], [7].
Standard approaches to reducing scatter include use of a bowtie filter to reduce the peripheral dose [8], [9] and an anti-scatter grid mounted to the flat-panel detector [10], [11]. However, scatter still contributes a substantial amount of signal to each projection. Numerous hardware- and/or software-based approaches have been proposed to estimate and correct for the remaining scatter signal. While there are too many of these techniques to enumerate, they can broadly be classified as belonging to one of several categories including: a) source intensity modulation [12], [13] or blocking [14]–[22], b) scatter deconvolution [23]–[27], c) utilizing a priori knowledge of the object [28]–[30], d) Monte Carlo modeling [31]–[39], or e) other empirical approaches [40]–[42].
Our motivation was to find a fast and accurate scatter correction method that would not require sophisticated hardware and could be used on existing platforms. Scatter deconvolution, also known as scatter kernel superposition (SKS), is the technique most widely applied commercially. The x-ray cone beam is modeled as an array of pencil beams that interact with the object. The scatter produced by each pencil beam is approximated by predetermined point-spread functions or kernels. SKS methods have the advantage of being computationally efficient (i.e., regarding real-time processing of projections) while not requiring additional hardware. We previously developed a variant of SKS – fast adaptive scatter kernel method (fASKS) – that uses object-dependent asymmetric scatter kernels to estimate and subtract scatter from projection images [25], [26]. The method has been used in the TrueBeam® product (Varian Medical Systems, Palo Alto, CA) and proven to be remarkably effective given the limitations of this class of corrections. However, SKS methods only approximate the interaction of x-ray photons with a heterogeneous object, which fundamentally limits their accuracy. Residual artifacts are often seen that limit CT number accuracy and can be clinically adverse (Fig. 1).
More accurate software-based scatter estimation and correction methods have been proposed, primarily based on Monte Carlo methods. In principle, Monte Carlo methods can model quite accurately how x-rays propagate through components of the imaging system and the imaged object. However, in practice, Monte Carlo calculations are typically slow and resource intensive, with there being a tradeoff between run times and the amount of stochastic noise present. While it is possible to improve performance by utilizing graphics processing units (GPUs), implementing variance reduction techniques, and simplifying the approximations of the underlying physics, it remains to be seen whether a sufficiently fast and accurate calculation can be achieved to meet clinical demands.
Under standard imaging conditions, the behavior of photons as they interact with an object is described by the linear Boltzmann Transport Equation (LBTE) [43]. There are two classes of methods for solving the LBTE – stochastic (i.e., Monte Carlo) and deterministic. Both Monte Carlo and deterministic methods inherently model the LBTE, but take fundamentally different approaches to solving it. The former repeatedly samples the behavior of individual particles to stochastically build up a solution, while the latter directly computes a discretized solution for the entire object. Stochastic and deterministic methods both converge to the same solution given enough simulated particles for the former or sufficiently fine discretization for the latter.
Recent advances in deterministic methods have shown great promise as an alternative to Monte Carlo techniques in applications such as dose calculation for radiotherapy treatment planning and, more generally, modeling particle transport [44]–[48]. In particular, Varian recently introduced Acuros® XB, a deterministic program providing computation speeds approaching those of kernel-based methods and accuracies equivalent to those of Monte Carlo methods [49]–[52]. Inspired by the success of Acuros XB, we sought to apply a similar deterministic approach to rapidly and accurately estimate scatter in kV projections to improve CBCT image quality. As a result, a new deterministic method called Acuros CTS was born [53], [54]. To our knowledge, this paper describes the first complete implementation and validation of a deterministic LBTE solver for estimating scatter in kV projection images.
The description of Acuros CTS and its use for scatter correction is organized as a two-part paper. In Part I, we first present the steps that form the LBTE solver in Acuros CTS. Then, we highlight the numeric methods used to produce a fast and accurate implementation. Finally, we demonstrate the ability of Acuros CTS to produce scatter estimates equivalent to Monte Carlo simulations while benchmarking computation times. In Part II [55], we describe how the imaging system is modeled and how Acuros CTS is used to correct for scatter in projection images with results demonstrated on phantom and clinical data on a commercial system. For brevity, we will henceforth refer to Acuros CTS simply as Acuros.
II. METHODS AND MATERIALS
The flow of photons during a CBCT projection can be organized overall into three steps: (1) photons travel from the x-ray source to the object, where they (2) interact and scatter, possibly multiple times, before (3) continuing their path into the detector panel. These steps, depicted in Fig. 2, are also natural steps in our computational effort. We have therefore organized the Acuros calculation accordingly.
Ray trace photons from the x-ray source to the object.
Compute the interaction of photons with the object.
Ray trace scattered photons from the object to the detector.
Thus, the result from an Acuros calculation is the detector’s scatter signal.
In each step of the algorithm, the steady state linear Boltzmann Transport Equation (LBTE) governs how photons behave:
(1) |
where
-
-
is the angular fluence (sometimes referred to as angular flux) which quantifies the tracks of particles in a differential volume about position with energy E traveling along the direction . Using the ICRU Report 85 convention for notation and units [56], the units to the angular fluence are .
-
-
is a source of photons to the LBTE. The photon source describes the number of photons inserted into position with energy E traveling along direction . The unit of the photon source term is . The maximum energy of all sources in the system is .
-
-
is a linear directional scatter coefficient (sometimes referred to as the directional scattering macroscopic cross section) that describes the fraction of photons having energy travelling along direction that scatter into a new direction with a new energy E. is an intrinsic property of the material(s) being modeled and can be thought of as a total cross section that encompasses all Compton and Rayleigh scattering events (photoelectric events that produce characteristic x-rays may also be included in the “scatter” model). The values for used in Acuros were obtained from theoretical Klein-Nishina and Thompson scatter coefficients for Compton and Rayleigh scattering, respectively [57]. We then adjusted these theoretical coefficients by the incoherent scattering and atomic form factor functions, which adjust the theoretical coefficient to the effects of the electron bounding energies [58]. The units of this directional coefficient are .
-
-
is the linear attenuation coefficient (sometimes referred to as the macroscopic total interaction cross-section) of the material(s) being modeled and accounts for all scattering and absorption events. The units of the linear attenuation coefficient are The total attenuation coefficient equals the scattering coefficient plus the photoelectric absorption coefficient. We derived photoelectric coefficients from the Biggs-Lighthill analytic model [59].
To better understand the LBTE, we describe each one of its terms physically:
The first term in Equation 1 is a projection of the gradient of the angular fluence distribution ). accounts for how x-rays stream across a differential volume.
The second term represents the angular fluence along the direction that collide with the object. This term includes all photoelectric absorption, and Rayleigh and Compton scattering events.
The third term provides a mechanism for introducing photons into the system, for example from an x-ray source either internal or external to the object.
The fourth term describes scattering interactions that can increase the angular fluence along the direction .
The LBTE states that for a given position and direction , the amount of streaming photons (first term) plus that which collide (second term) is equal to the angular fluence generated by external sources (third term) plus that which scatters into with direction (fourth term). The spatially dependent object material and density maps, which form both and , are assumed to be known a priori, e.g., as from a reconstructed CT scan. Finally, for kV imaging, the photon energies are too low to merit the explicit modeling of secondary electrons. Instead, where an interaction occurs that produces Compton or Auger electrons, the electrons are assumed to travel a negligible distance and deposit their energies locally.
The angular fluence distribution in the LBTE can be solved analytically for a limited subset of problems, for example, when radiation travels through a purely absorbing material (or scatter is ignored) or in problems where there is scatter but the geometry is one dimensional [60]. More commonly, a generalized LBTE solution is numerically computed either through Monte Carlo or deterministic methods whose solutions will converge to each other given enough time and resources [43]. While Monte Carlo methods arrive at their answer by statistically sampling the underlying (absorption and scattering) probability density functions (PDFs) that govern x-ray transport and then propagating particles stochastically according to those PDFs, deterministic methods iteratively solve the LBTE by propagating a current iteration of the angular fluence estimate across the object and updating the estimate for the next iteration, based on the predicted effects of the local values of and , until convergence is reached. The advantages of deterministic methods are that they produce a solution over the entire LBTE domain (cf. Monte Carlo tallies) and, with efficient implementation, can be fast relative to the stochastic Monte Carlo approach [43].
We implemented a combination of analytic and deterministic techniques in Acuros to solve the LBTE. Specifically, the ray tracing operations in Steps 1 and 3 were performed analytically. For Step 2, a deterministic approach was chosen based on the well-known Linear Discontinuous Finite Element, Multigroup, and Discrete Ordinates methods for discretization along the spatial, energy, and angular domains, respectively. Although these methods are partly described in the literature [43], we include a brief description here for completeness since our implementation forms a unique combination of methods for kV imaging.
A. Continuous Domains
This section describes Acuros’ three steps with a continuous representation of the spatial, energy and angular domains. It best illustrates the methodology employed to solve the LBTE. However, we do not solve the LBTE in the continuous domain. In section B, we show how the problem is discretized and the Acuros solver implemented.
A.1. Source-to-object ray trace
In Acuros’ first step, we trace photons as they depart from the x-ray source , arrive to the object, and first interact. Our goal is to compute a distribution of uncollided (UC) angular fluence (i.e., photons that have not been absorbed or scattered) inside the object, then assemble a first-collision source to drive the next step of the algorithm. We begin by tracing the angular fluence from the source position to the object, and remove photons as they are absorbed or scattered:
(2) |
where is the source that drives the uncollided problem (in units of ) and is defined on a singular point in space – i.e. the focal point of our beam from which x-rays emanate. We can analytically solve for the uncollided since all uncollided photons arrive to any point from a single position :
(3) |
Here is an evaluation point inside the object, is a unit vector pointing in the streaming direction from the x-ray source located at to this evaluation point and l is a variable of integration along the streaming direction. Variations in angular intensity due to the heel effect, collimation and/or a bowtie filter are assumed to be known a priori and can be incorporated into the point source distribution . Note that Eq. 3, which shows that the uncollided angular fluence arriving at a given location r is simply the exponentially attenuated source fluence S(0) divided by thus confirming Beer’s law and the inverse-square law.
Once the uncollided fluence entering each location in the object is computed, we calculate the magnitude and distribution of, what is termed, the first-scattered or first-collision (FC) scattering source:
(4) |
We note that since , this energy integral assumes that photons cannot gain energy from scattering events. Particles arrive to from the uncollided direction only. We therefore do not need to integrate the scattering kernel in angle to evaluate the first-collided source. The nature of the uncollided fluence automatically simplifies this integral.
A.2. Scattering source calculation
In this second step, we transport photons as they travel and collide multiple times with the object to produce higher-order scattering sources. While the first-collision scattering source computed in A.1 is, by nature (e.g., as described by Thompson and Klein-Nishina scattering equations [57]), forward peaked along the direction , the higher-order scattering sources are more isotropic and as shall be shown, can be efficiently modeled using spherical harmonic functions. The combined scattering sources of all orders produce a total scattering source for each position in the object, which then drives the final step of computing the scatter signal measured at the detector.
The LBTE describing this second step is more complex than for the first step since the scattering term now couples the angular fluence from all streaming directions, :
(5) |
Here the superscript C indicates that this solution is the collided component of the angular fluence (i.e., photons that have scattered at least once within the object). Unlike for the first step, there is no generalized analytic solution to compute the angular fluence distribution, as the LBTE is now an integro-differential equation. Thus, we rely instead on numerical techniques.
We choose the Source Iteration (SI) method to solve the problem [61]. To understand SI, consider expanding the collided angular fluence into a series:
(6) |
where n is the number of collisions that each generation of the angular fluence has encountered. That is, is the angular fluence of particles that has scattered only once with the object, is the twice-scattered fluence, etc. We ignore because this is the angular fluence of uncollided particles , which we have already addressed (step 1).
SI solves each generation n of the angular fluence distribution sequentially. First, we solve , then , and so forth. The LBTE for each generation n has only three terms, the particle streaming and interaction terms plus the scattering source from the higher order fluence:
(7) |
where is the unknown angular fluence and is the amount of (scattered) particles emerging from their collision:
(8) |
Here is known; we obtained it in the previous iteration of our process. Note that, on average, each generation has a smaller fluence magnitude than the previous one since not all photons will scatter into the next generation – some photons will instead escape from the object while others will be absorbed. Therefore, after a finite number N iterations, the calculation converges and contributions from further iterations are negligible (i.e., our collided fluence expansion is truncated after N terms):
(9) |
We apply a convergence criteria of < 0.1% change between iterations, which in our experience, requires only a modest number of iterations (typically 10 < ) for keV photons compared to the dozens of iterations required for optical photons or the hundreds needed to model low absorption environments like thermal neutrons in water [43].
The complete multiple-collision source is the number of particles that have scattered at least twice:
(10) |
A.3. Scatter Image
In the remaining step of the algorithm, the scattered photons are ray traced to the detector. The solution to the LBTE for the angular fluence at detector point for those particles arriving with direction along the line l is:
(11) |
This calculation is analogous to the first step of the algorithm, except that now a distributed source is being ray traced to locations on the detector panel. The exponential attenuation in Eq. 11 deserves special attention. While it may be intuitive to remove x-rays that are absorbed in the object, it may be somewhat counterintuitive to also remove those x-rays that scatter since we, after all, seek to compute the scatter image. However, these x-rays have already been accounted for in the source iteration process and must not be double-counted.
The detected scatter signal is then the integral of the fluence over all energies and angles, weighted by the grid and detector responses:
(12) |
where G is the generalized grid response (e.g., transmission fraction) and D is the generalized detector response (e.g., energy deposited). By integrating over all angles, we ensure that the contributions from the entire object volume is collected.
A.4. Primary image
The primary image P is a weighted response to the uncollided photons that travel from the source through the object to the detector. As in Step 1 above, we analytically trace rays, this time from the beam origin to the detector while removing those photons that interact with the object. The analytic LBTE solution for this ray trace is the familiar Beer’s and inverse-square laws, combined with the grid and detector responses:
(13) |
where is the direction of a primary ray from the point source position to detector position .
B. Discrete Domains
The expressions in Section A describe the LBTE in continuous space, energy, and directional domains. In practice, we discretize the transport problem to make it computationally tractable. These numerical methods are designed to be very close approximations to the continuous problem while providing for clinically acceptable run times utilizing readily available computer architectures. Furthermore, these discretizations offer the advantage of being convergent. That is, as the computational mesh becomes finer, the discretized solution approaches the continuous solution.
At the core of the calculation is a spatial grid that describes the object’s material properties, providing a framework for evaluating the angular fluence distribution. The Acuros voxels were chosen to be rectangular cuboid shaped. The Acuros computational mesh is therefore uniform (all voxels have equal size) and orthogonal (built on voxels). Moreover, each step in the Acuros calculations uses the same computational grid, simplifying the coupling of the three steps. Given the computational mesh, we reserve the index i to indicate voxel i.
The next domain is energy, where the spectrum is organized into a set of energy bins or groups indexed by g:
(14) |
Traditionally, energy groups are organized from the most energetic to the least (i.e., group 1 is the highest energy group and group G the least energetic one), where each group is bound by energies . The energy group structure is used throughout the LBTE for discretizing the x-ray source spectrum, total attenuation, and scatter coefficients. In our work, we used 6 energy groups separated by predetermined energy thresholds. While this was felt to be sufficient, the number of groups and their thresholds could be further explored in future work.
B.1. Source-to-object ray trace
In this step, we describe the uncollided fluence inside voxel i for group g. Then we define the first-collided source belonging to this group and voxel. The discretized uncollided fluence closely resembles its continuous counterpart:
(15) |
Here the source spectrum has now been collapsed into G energy groups. The total interaction coefficient has also been collapsed into its group equivalent form in a way that conserves the group’s attenuation [43]. Finally, we apply Siddon’s algorithm to ray trace through the object [62]. The attenuation of each intersected voxel is weighted by the path length ( ) of the ray inside that voxel. With this description, Acuros accumulates the ray’s line integral of the attenuation coefficient through the object and exponentially attenuates the uncollided rays.
Given the uncollided fluence, the first-collided distributed source inside voxel i for energy group g is:
(16) |
Here is the first-collided scatter source, is the group-collapsed linear scatter coefficient from group into group g inside voxel i, and is the uncollided angular fluence. Note that the down-scatter energy integral has been replaced by a summation of down-scattering groups.
B.2. Scattering Source Calculation
We now define how to compute the multiple-collision source, step 2 in the Acuros algorithm. The multiple-collision source, Eq. 8, integrates the contribution from a continuum (in angle) of angular fluences. Evaluating this integral is challenging. We must evaluate the entire angular fluence continuum or somehow approximate the angular integral. We avoided this challenge in the previous step since the uncollided fluence is defined only in one direction: from the beam’s focal point to the coordinate of interest.
To evaluate the multiple-collision source integral, we implemented the Discrete Ordinates (DO) method to discretize the streaming direction into a set of M angles that span 4π [43], [63]. The multiple-collision integral for the nth Source Iteration becomes:
(17) |
Here is the collided angular fluence along direction . The multiple-collision source angular integral is now approximated by a quadrature integral, where each direction is assigned a quadrature weight for its evaluation. In addition, is the scattering coefficient from energy group to group g and from direction into direction . Consequently, we collapsed the multiple-collision source integral into a summation of energy groups and directions.
The DO approach avoids the need to map the scatter contribution from each point in the object to all its neighbors – a algorithm for a problem with I voxels. By solving the angular fluence only along M directions for each voxel, we reduce this effort to an algorithm (with ). The set of streaming directions and their corresponding weights are pre-selected to maximize the accuracy of the angular integral. Problems with low anisotropy such as the MC source require a small M to capture this integral accurately. Problems with high anisotropy such as the FC source would require a large M if using DO, but we avoid this by evaluating the FC source analytically.
The scatter coefficients can be simplified by condensing the discrete directions into a single variable , the inner product of the two vectors. This simplification stems from the physics of scattering interactions; the probability of a scattering event depends on the outgoing direction relative to the incoming one, . We exploit this simplification to represent scattering coefficient sections with a Legendre series :
(18) |
Here is the l-th Legendre moment of the linear scattering coefficient (computed a priori), with the series being truncated after L terms.
To continue reducing the cost of evaluating the multiple-collision source, we expand the angular fluence distribution for each voxel and energy group into its own Spherical Harmonics series:
(19) |
where are Spherical Harmonics functions of degree l and order k, and are known as the spherical harmonics fluence moments. Due to the orthogonality of the Spherical Harmonic functions, the moments can be determined from the angular fluence using quadrature weighting:
(20) |
where * is the complex conjugate.
To calculate the scattering source from the angular fluence, we insert the Legendre expansion of the scattering coefficient, Eq. 18, and the Spherical Harmonics expansion of the fluence, Eq. 19, into the scatter source, Eq. 17. The result is:
(21) |
which, like the angular fluence, is also represented by spherical harmonic functions. The derivation can be found in the Appendix and reference [43].
Next, we apply the Linear Discontinuous (LD) finite element method [64], [65] to discretize the LBTE in space. We seek a method to evaluate the angular fluence inside voxel i, energy group g and streaming direction m. The LD method approximates the spatial variation of the angular fluence within a voxel with a set of first-order polynomials and provides a framework to evaluate its unknowns:
(22) |
Here is a linear Legendre polynomial, , and are spatial coordinates of point in a coordinate system local to voxel i, and , , , and are the LD unknowns also for voxel i. Note that these amplitudes are only defined within this voxel, and it is the union of the across all voxels that defines the complete LD solution to the LBTE.
To compute the LD angular fluence amplitudes, we project the LBTE into the LD solution space , the details of which are in the Appendix. As a result, this spatial discretization produces a system of 4 equations (one for each weighted moment of the LBTE) and 4 unknowns (the angular fluence amplitudes) for each voxel, energy group, and streaming direction.
An important aspect to stress is that the LD method implicitly communicates to each voxel its boundary conditions. This choice is important, as it implies that the LD method does not require the angular fluence be continuous across the faces of a voxel. Although discontinuities across voxel faces are non-physical, the LD method is said to super-converge since volume integrals of its solution exhibit quadratic convergence (or a cubic error) of a solution built on linear polynomials. Armed with a super-convergent method, Acuros can compute sharp variations in the angular fluence accurately and with relatively few (and large) voxels. We refer to the LD literature for further review on it mechanics and properties [64], [65].
In step 2 of the Acuros algorithm, the multiple-collision source is computed. We presented three methods to discretize the LBTE in space (Linear Discontinuous), energy (Multigroup), and angle (Discrete Ordinates). The product of these discretizations is angular fluence unknowns and the matching number of moments of the LBTE. We solve these amplitudes iteratively by assembling the latest scattering source, transporting (along M discrete directions) the x-rays it emits across the object (I voxels) and updating the angular fluence ( unknowns per voxel). This Source Iteration process is performed until the angular fluence converges for all G energy groups. We then collect the moments of the collided angular fluence:
(23) |
and compute the multiple-collision source in the direction :
(24) |
B.3. Scattering source to detector
In step 3 of Acuros, we evaluate the FC and MC sources in the direction of the detector panel, transport the combined x-ray emissions in the panel’s direction, and accumulate the energy deposited in the detector. The scatter signal is the accumulation of these emissions from scatter sources in all voxels. To organize this calculation the angular fluence arriving to our detector from a position inside voxel i is defined:
(25) |
Here is the angular fluence of group g arriving at point in the detector pixel. is the streaming direction pointing from to , and is a point inside voxel i. Similar to step 1 in our algorithm, a ray-trace is performed to determine the ray’s line integral of the attenuation coefficient and attenuate the ray accordingly. We again use Siddon’s algorithm to determine which voxels ( ) each ray intersects and the length of each voxel intersection ( ).
The contribution of to the scatter signal is:
(26) |
where is the contribution to the scatter signal from point in voxel i to point in the panel. The grid and detector responses have been simplified, as described below in Sec. C. To numerically integrate the total contribution from voxel i to this point in the detector, we subsample each voxel by applying a spatial quadrature, where are quadrature points (j) inside voxel i, and are quadrature weights. To determine the total scatter signal in a pixel (u), we also subsample each pixel with a spatial quadrature and sum over all voxels and energy groups:
(27) |
where and are the quadrature weights and points, respectively, that numerically integrate the area of the pixel.
B.4. Computation of primary
The computation of the primary signal in a pixel ( ) closely mimics its analytic counterpart. We apply pixel subsampling, our group structure, and simplified anti-scatter grid and detector models:
(28) |
Here is beam strength of group g along the primary direction . Each primary ray is traced from the beam’s focal point to in the panel. The ray’s line integral of the attenuation coefficient is evaluated with Siddon’s algorithm, as exemplified in step 1 and 3 of the scatter signal calculation. Finally, pixel subsampling is used to find the total primary signal in pixel u, where and form the spatial quadrature that integrates the area of pixel u.
C. Generating the grid and detector responses
The generalized grid and detector responses can be difficult to model if they are dependent on all 3 variables (location, energy, and angle). Fortunately, the response functions can be simplified by making reasonable assumptions. For example, our models include a 1D anti-scatter grid that is assumed to be spatially invariant and is dependent on two angles , where is with respect to the focusing direction in the v-source plane and is with respect to the normal direction in the u-source plane (Fig. 3). The grid response is then simplified to:
(29) |
Therefore, a 2D look-up table (LUT) in for each energy group g is sufficient to characterize G. The response was pre-computed using a Geant4 (v9.6) [66] simulation of transmission fractions through the grid. TrueBeam’s 10:1 grid was modeled as a series of lead strips focused at the source, using the manufacturer’s specifications: 60 line pairs/cm, 36 μm lamellae thickness, 1.5 mm lamellae height, and 150 cm focal distance (Smit Roentgen, Philips, Best, Netherlands). A line beam of length 1/60 cm in the v-direction was directed at the modeled grid at various angles to determine the average transmission of each energy group, which was then stored as a LUT in Acuros.
The detector response was simplified further by assuming it is spatially invariant, but dependent on the angle between the incident direction and the normal vector of the detector plane, accounting for the effectively thicker scintillator encountered by non-perpendicular rays:
(30) |
Accordingly, D can be represented as a 1D LUT in for each energy group g. The detector response was modeled using a Geant4 simulation of energy deposited in the Cesium Iodide (CsI) scintillator (600 μm thick, ρ=4.51 g/cm3) in TrueBeam’s flat-panel imager. For each energy group, a pencil beam was directed at the scintillator at varying angles to determine Dg. It was then assumed the detected signal (analog-digital units, ADU) is proportional to the energy deposited.
D. Monte Carlo validation
Validation was performed by comparing Geant4 Monte Carlo results with Acuros results for projections of two digital phantoms. A simple geometric phantom composed of water, lung, air, and bone materials (WLAB) was used to test various components (fluence, energy deposited in detector, grid model) of the Acuros calculation. The WLAB phantom (Fig. 4a) is composed of a right rectangular prism of water (20×30×40 cm3, ρ=1.0 g/cm3), with lung (6×6×40 cm3, ρ=0.26 g/cm3), air (2×2×40 cm3, ρ=1.205×10−3 g/cm3), and bone (2×2×40 cm3, ρ=1.85 g/cm3) inserts. The phantom extends ±20 cm in/out of the page, while the detector extends ±15 cm in/out of the page. The phantom was defined using geometrical primitives in Geant4, while Acuros modeled the phantom using isotropic 1 cm voxels. The geometry of the imaging system is illustrated in Fig. 4a and was similar to that of TrueBeam in full-fan position – 100 cm source-axis distance, 150 cm source-detector distance, and a centered 40×30 cm2 detector. The isotropic x-ray point-source was collimated to the detector. For the Geant4 simulations, photon energies were sampled from a 125 kVp Bremsstrahlung spectrum while Acuros binned the same spectrum into 6 energy groups. The spectrum was validated to match the half-value layer attenuation properties of the TrueBeam system (no bowtie filter) including its standard 0.89 mm Ti filter. The 10:1 grid and 600 μm CsI scintillators described above were physically modeled in the Geant4 simulations, while their pre-computed response functions were used in Acuros. Both Acuros and Geant4 discretized the detector into 100×75 pixels of size 4×4 mm2. The primary and scatter images were recorded for fluence (photons / mm2) at the detector (without grid), as well as energy deposited in the detector (without, with grid). The Geant4 Livermore physics model was used with a range cut of 0.1 mm (with similar results obtained from Geant4 Penelope physics, not shown) [67], [68]. The Geant4 spectrum, material definitions, and results have been included as supplemental material with the manuscript.
A second digital phantom with more realistic anatomy and density variations was also tested. A pelvis CT volume was converted from CT numbers into water and bone of variable density (Fig. 5). The patient volume was placed on top of a digital model of Varian’s standard IGRT patient couch, as the patient couch is known to be a substantial source of scatter in certain views [26]. Details of the CT number conversion to material density process and of the patient couch model are presented in Part II. The patient was fairly large, with ~40 cm lateral width. The Geant4 simulation utilized the high spatial resolution of the CT volume with isotropic 1.25 mm voxels. The volume was down-sampled for Acuros by a factor of 10× in each direction, enabling each of Acuros’ isotropic 12.5 mm voxels to represent 10×10×10 of the original voxels by taking the average water and bone densities of each subvolume. Because down-sampling was performed by an integer factor, the down-sampled grid boundaries were aligned with the original grid boundaries. The simulated imaging system was identical to that of the WLAB phantom, with the exception of the beam being collimated to the detector in half-fan position (lateral shift of 16 cm) and the addition of an analytic model of TrueBeam’s half-fan bowtie filter.
Geant4 simulations were conducted with an in-house distributed network of computers (HTCondor, University of Wisconsin, Madison, WI) without any acceleration or variance reduction. Acuros was run on a standard workstation, with the core algorithms written in the CUDA programming language (CUDA 8.0, Nvidia, Santa Clara, CA) and run on a GPU (GeForce GTX 1080, Nvidia, Santa Clara, CA).
III. RESULTS
A. Digital WLAB phantom
WLAB results are shown in Fig. 6 comparing primary and scatter images of fluence at the detector (without grid) that were generated by Acuros and Geant4. The primary images show variable attenuation due to the air, bone, and lung inserts. The scatter images are smooth, and the effect of the inserts is not immediately apparent. Horizontal line profiles across the center of the image show excellent agreement between Geant4 and Acuros for both primary and scatter fluence, with an average relative difference of and , respectively. Because the results are normalized to 1 photon/steradian at the source, the fluence at the detector is on the order of photons/mm2.
The scatter fraction (SF) is a useful metric for quantifying the joint accuracy of primary and scatter images, and is defined as the scatter signal divided by the total (primary plus scatter) signal:
(31) |
The SF for energy deposited in the detector without and with the grid is shown in Fig. 7, again demonstrating the excellent agreement between Geant4 and Acuros. The average relative SF difference was without the grid and with the grid, respectively. The results with the detector but without a grid support the simplified detector response model, and the results with the addition of a grid support the simplified grid response model.
For these experiments, Acuros had a major computation time advantage. The WLAB scatter image with 7,500 detector pixels was computed in only 1.1 seconds using a single GPU for an object comprising 24,000 voxels. For the Geant4 simulation source photons were launched, with the computation taking ~1200 CPU-hours on our distributed computing system. Note some noise (0.4% relative to the mean) is still visible in the Geant4 scatter image, while the Acuros result is free of stochastic errors.
B. Digital pelvis phantom
Results from the digital pelvis phantom simulation are shown in Fig. 8. Two (half-fan) projection angles (0° and 270°) were compared. Primary and scatter images of energy deposited in the detector for the 0° anterior-posterior (AP) projection show good visual agreement. Although the same source photons were used in Geant4, noise in the scatter image is much more apparent than with the WLAB phantom due to the higher attenuation of the pelvis. Horizontal line profiles of SF across the central row show the strong agreement between Geant4 and Acuros. The 270° lateral projection experiences a higher SF behind the object due to greater attenuation and scatter coming from the patient couch. Despite the presence of the bowtie filter and anti-scatter grid, the SF goes as high as 0.85 (or equivalently, a scatter-to-primary ratio (SPR) of 5.5). Nevertheless, the average relative difference in SF between Acuros and Geant4 is only 0.1%.
IV. DISCUSSION
Our results show excellent agreement between Monte Carlo- and Acuros-generated scatter estimates, first for a simple geometric object and then for a more realistic example of a spatially-varying x-ray beam projecting through a heterogeneous object. The CBCT system that was modeled consisted of a polychromatic kV x-ray source, bowtie filter, and an energy-integrating indirect detector with an anti-scatter grid. Despite discretizing the problem using coarse voxels, limited energy groups, and a finite number of streaming directions, Acuros’ accuracy was equivalent to that provided by the Monte Carlo methods, which used finer voxels (or geometrical primitives), a continuous energy spectrum, and continuous directions. The ability to achieve such a good correspondence is due in part to the low-frequency nature of the projected scatter image, but also due to carefully constructed discretization methods.
We measured Acuros run times of ~1 sec/projection for fairly representative problems using a single GPU. Conversely, the (CPU) Monte Carlo implementations were not optimized for speed. Rather, they were intended to produce a high-quality solution with minimal noise as required to benchmark Acuros’ accuracy. Consequently, a direct comparison between Geant4 and Acuros run times is difficult due to the lack of implementing run-time optimization techniques for Monte Carlo, including variance reduction methods and GPU implementation. As such, the purpose of this study was not to determine which method is inherently faster for this application, but rather to determine if Acuros’ accuracies and run times are well suited for our clinical applications. This was found to be the case as reported in Part II, where we explore the trade-offs between scatter estimation accuracy and run times.
Although many of the underlying algorithms are shared between Acuros CTS and Acuros XB, key differences exist. First, Acuros CTS was designed and optimized for estimating primary and scatter images, whereas Acuros XB (external beam) and BV (brachytherapy) were designed to compute dose delivered to a patient. Acuros CTS incorporates the last-collided technique and anti-scatter grid and detector models to form the scatter image from scattering sources that lie within the object. This computationally expensive step requires ray tracing from every object voxel to every detector pixel, but can be performed efficiently on a GPU. Additionally, Acuros CTS does not model electron transport (which is negligible at kV energies), does not utilize adaptive mesh refinement (a uniform spatial grid is sufficient for estimating scatter), and does not require secondary source modeling (a point source is sufficient).
Acuros was designed to provide a flexible framework for estimating scatter and primary images at diagnostic energies. To match actual imaging conditions, the user can specify the x-ray beam’s spectrum and distribution, system geometry, object’s material and density distribution, grid response, and detector size and response. Although designed with cone-beam CT in mind, Acuros may be able to extend to other medical imaging modalities such as radiography, PET, or SPECT or other applications such as security or industrial imaging. We have also begun investigation of Acuros CTS for calculating radiation dose delivered by a kV imaging system, similar to how the original Acuros XB code calculates MV treatment dose. This is a natural fit for Acuros CTS since the calculation required (angular fluence within the object) is already performed in the second step. So, essentially, we stop before ray tracing the fluence from the volume to the detector. Once the angular fluence distribution is calculated, we can convert to dose delivered by using the mass density and mass energy-absorption coefficient of each voxel, which is simply a property of its materials. While the full details of our preliminary dose study are beyond the scope of this paper, the Acuros CTS results showed excellent agreement with Geant4 simulations [69]. We anticipate being able to use Acuros CTS to compute dose from a cone-beam CT scan or for diagnostic CT scans, where there is great interest in better dose reporting [70], [71].
V. CONCLUSION
We have described Acuros CTS, a new software tool for fast and accurate scatter estimation in kV imaging applications that can be used as an alternative to Monte Carlo methods. We have demonstrated that the LBTE can be deterministically solved using a combination of efficient discretization methods implemented on parallel-computing platforms, with validation against Monte Carlo simulations. In Part II, we will discuss modeling a clinical CBCT system with Acuros CTS and using the output to remove the scatter signal from the projection data before reconstruction.
Supplementary Material
Acknowledgments
The authors would like to thank Henry Ford Health System (Detroit, MI) for providing clinical data. This work was partially supported by NIH U01EB023822.
APPENDIX A: LEGENDRE POLYNOMIAL AND SPHERICAL HARMONICS EXPANIONS
Substituting the Legendre polynomial and Spherical Harmonic expansions, into Eq. 17, we find:
(A1) |
Therefore, to evaluate the scattering source in direction , we must evaluate two polynomial expansions. This is an expensive proposition. To combine and simplify this expansion, we refer to the Addition Theorem for Legendre Polynomials:
(A2) |
Furthermore, we reorganize the scattering source terms to take advantage of the orthogonality of Spherical Harmonics functions:
(A3) |
where and are orthogonal functions:
(A4) |
Here M is large enough so that it exactly integrates spherical harmonic functions of degree and order thus reducing the scatter source expression to Eq. 21.
APPENDIX B: LINEAR DISCONTINUOUS SOLUTION SPACE
To project the LBTE into the LD solution space, we integrate the LBTE over the volume of the voxel, weigh this integral by each function in the solution space, and replace the angular fluence by its LD definition. For example, the projection is:
(B1) |
Here we have integrated the LBTE of the source iterate of the collided fluence, . The integral was weighted by the function and is defined over the volume of voxel i. We applied the Divergence Theorem to cast the integral of the first term into a surface integral form. This surface integral evaluates the angular fluence on the voxel surface and communicates to each the voxel boundary conditions from its upstream neighbors. is a vector normal to the voxel’s surfaces that points outwards. The integral of the interaction term (second term on the right-hand side) was simplified. Here we exploited the orthogonality properties of Legendre polynomials to ignore those integrals that are equal to zero. Finally, the integral of the source term equals:
(B2) |
where we have integrated the moment of , the source of the iteration of group g and streaming direction m. We have two formulations for this integrand. The first belongs to the initial step in the Source Iteration process ( ). Here, the driving source is the first-collision source. We numerically evaluate this integral over the volume of the voxel using a quadrature set of J points and weights . The second integrand evaluates the moments of the multiple-collision source, where we use the properties of Legendre Polynomials to evaluate the volume integral.
References
- 1.Jaffray DA, Siewerdsen JH, Wong JW, Martinez AA. Flat-panel cone-beam computed tomography for image-guided radiation therapy. Int J Radiat Oncol. 2002 Aug;53(5):1337–1349. doi: 10.1016/s0360-3016(02)02884-5. [DOI] [PubMed] [Google Scholar]
- 2.Orth RC, Wallace MJ, Kuo MD. C-arm Cone-beam CT: General Principles and Technical Considerations for Use in Interventional Radiology. J Vasc Interv Radiol. 2008 Jun;19(6):814–820. doi: 10.1016/j.jvir.2008.02.002. [DOI] [PubMed] [Google Scholar]
- 3.Scarfe WC, Farman AG, Sukovic P. Clinical applications of cone-beam computed tomography in dental practice. J Can Dent Assoc. 2006;72(1):75–80. [PubMed] [Google Scholar]
- 4.Endo M, Tsunoo T, Nakamori N, Yoshida K. Effect of scattered radiation on image noise in cone beam CT. Med Phys. 2001 Apr;28(4):469–474. doi: 10.1118/1.1357457. [DOI] [PubMed] [Google Scholar]
- 5.Siewerdsen JH, Jaffray DA. Cone-beam computed tomography with a flat-panel imager: Magnitude and effects of x-ray scatter. Med Phys. 2001 Feb;28(2):220–231. doi: 10.1118/1.1339879. [DOI] [PubMed] [Google Scholar]
- 6.Rührnschopf E-P, Klingenbeck K. A general framework and review of scatter correction methods in x-ray cone-beam computerized tomography. Part 1: Scatter compensation approaches. Med Phys. 2011 Jun;38(7):4296–4311. doi: 10.1118/1.3599033. [DOI] [PubMed] [Google Scholar]
- 7.Rührnschopf E-P, Klingenbeck K. A general framework and review of scatter correction methods in cone beam CT. Part 2: Scatter estimation approaches. Med Phys. 2011 Aug;38(9):5186–5199. doi: 10.1118/1.3589140. [DOI] [PubMed] [Google Scholar]
- 8.Mail N, Moseley DJ, Siewerdsen JH, Jaffray DA. The influence of bowtie filtration on cone-beam CT image quality. Med Phys. 2009 Dec;36(2009):22–32. doi: 10.1118/1.3017470. [DOI] [PubMed] [Google Scholar]
- 9.Graham SA, Moseley DJ, Siewerdsen JH, Jaffray DA. Compensators for dose and scatter management in cone-beam computed tomography. Med Phys. 2007 Jun;34(7):2691–2703. doi: 10.1118/1.2740466. [DOI] [PubMed] [Google Scholar]
- 10.Siewerdsen JH, Moseley DJ, Bakhtiar B, Richard S, Jaffray DA. The influence of antiscatter grids on soft-tissue detectability in cone-beam computed tomography with flat-panel detectors. Med Phys. 2004 Nov;31(12):3506–3520. doi: 10.1118/1.1819789. [DOI] [PubMed] [Google Scholar]
- 11.Sisniega A, Zbijewski W, Badal A, Kyprianou IS, Stayman JW, Vaquero JJ, Siewerdsen JH. Monte Carlo study of the effects of system geometry and antiscatter grids on cone-beam CT scatter distributions. Med Phys. 2013 May;40(5):51915. doi: 10.1118/1.4801895. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 12.Zhu L, Bennett NR, Fahrig R. Scatter Correction Method for X-Ray CT Using Primary Modulation: Theory and Preliminary Results. IEEE Trans Med Imaging. 2006 Dec;25(12):1573–1587. doi: 10.1109/tmi.2006.884636. [DOI] [PubMed] [Google Scholar]
- 13.Gao H, Fahrig R, Bennett NR, Sun M, Star-Lack J, Zhu L. Scatter correction method for x-ray CT using primary modulation: Phantom studies. Med Phys. 2010 Jan;37(2):934–946. doi: 10.1118/1.3298014. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 14.Ning R, Tang X, Conover D. X-ray scatter correction algorithm for cone beam CT imaging. Med Phys. 2004 Apr;31(5):1195–1202. doi: 10.1118/1.1711475. [DOI] [PubMed] [Google Scholar]
- 15.Zhu L, Xie Y, Wang J, Xing L. Scatter correction for cone-beam CT in radiation therapy. Med Phys. 2009 May;36:2258–2268. doi: 10.1118/1.3130047. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 16.Lee H, Xing L, Lee R, Fahimian BP. Scatter correction in cone-beam CT via a half beam blocker technique allowing simultaneous acquisition of scatter and image information. Med Phys. 2012 Apr;39(5):2386–2395. doi: 10.1118/1.3691901. [DOI] [PubMed] [Google Scholar]
- 17.Wang J, Mao W, Solberg T. Scatter correction for cone-beam computed tomography using moving blocker strips: A preliminary study. Med Phys. 2010 Oct;37(11):5792–5800. doi: 10.1118/1.3495819. [DOI] [PubMed] [Google Scholar]
- 18.Niu T, Zhu L. Scatter correction for full-fan volumetric CT using a stationary beam blocker in a single full scan. Med Phys. 2011 Oct;38(11):6027–6038. doi: 10.1118/1.3651619. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 19.Jin J-Y, Ren L, Liu Q, Kim J, Wen N, Guan H, Movsas B, Chetty IJ. Combining scatter reduction and correction to improve image quality in cone-beam computed tomography (CBCT) Med Phys. 2010 Oct;37(2010):5634–5644. doi: 10.1118/1.3497272. [DOI] [PubMed] [Google Scholar]
- 20.Yang K, Burkett G, Boone JM. A breast-specific, negligible-dose scatter correction technique for dedicated cone-beam breast CT: a physics-based approach to improve Hounsfield Unit accuracy. Phys Med Biol. 2014 Nov;59(21):6487–505. doi: 10.1088/0031-9155/59/21/6487. [DOI] [PubMed] [Google Scholar]
- 21.Min J, Pua R, Kim I, Han B, Cho S. Analytic image reconstruction from partial data for a single-scan cone-beam CT with scatter correction. Med Phys. 2015 Oct;42(11):6625. doi: 10.1118/1.4933423. [DOI] [PubMed] [Google Scholar]
- 22.Ouyang L, Song K, Wang J. A moving blocker system for cone-beam computed tomography scatter correction. Med Phys. 2013 Jun;40(7):71903. doi: 10.1118/1.4811086. [DOI] [PubMed] [Google Scholar]
- 23.Love LA, Kruger RA. Scatter estimation for a digital radiographic system using convolution filtering. Med Phys. 1987 Mar;14(2):178–185. doi: 10.1118/1.596126. [DOI] [PubMed] [Google Scholar]
- 24.Seibert JA, Boone JM. X-ray scatter removal by deconvolution. Med Phys. 1988 Jul;15(4):567–575. doi: 10.1118/1.596208. [DOI] [PubMed] [Google Scholar]
- 25.Sun M, Star-Lack JM. Improved scatter correction using adaptive scatter kernel superposition. Phys Med Biol. 2010 Nov;55(22):6695–720. doi: 10.1088/0031-9155/55/22/007. [DOI] [PubMed] [Google Scholar]
- 26.Sun M, Nagy T, Virshup G, Partain L, Oelhafen M, Star-Lack J. Correction for patient table-induced scattered radiation in cone-beam computed tomography (CBCT) Med Phys. 2011;38(4):2058–2073. doi: 10.1118/1.3557468. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 27.Stankovic U, Ploeger LS, Herk M van, Sonke J-J. Optimal combination of anti-scatter grids and software correction for CBCT imaging. Med Phys. 2017 Aug; doi: 10.1002/mp.12385. [DOI] [PubMed] [Google Scholar]
- 28.Niu T, Sun M, Star-Lack J, Gao H, Fan Q, Zhu L. Shading correction for on-board cone-beam CT in radiation therapy using planning MDCT images. Med Phys. 2010 Sep;37(10):5395–5406. doi: 10.1118/1.3483260. [DOI] [PubMed] [Google Scholar]
- 29.Marchant TE, Moore CJ, Rowbottom CG, Mackay RI, Williams PC. Shading correction algorithm for improvement of cone-beam CT images in radiotherapy. Phys Med Biol Phys Med Biol. 2008 Oct;53(53):5719–5733. doi: 10.1088/0031-9155/53/20/010. [DOI] [PubMed] [Google Scholar]
- 30.Niu T, Al-Basheer A, Zhu L. Quantitative cone-beam CT imaging in radiation therapy using planning CT as a prior: First patient studies. Med Phys. 2012 Mar;39(4):1991–2000. doi: 10.1118/1.3693050. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 31.Colijn AP, Beekman FJ. Accelerated simulation of cone beam X-Ray scatter projections. IEEE Trans Med Imaging. 2004 May;23(5):584–590. doi: 10.1109/tmi.2004.825600. [DOI] [PubMed] [Google Scholar]
- 32.Zbijewski W, Beekman FJ. Efficient Monte Carlo based scatter artifact reduction in cone-beam micro-CT. IEEE Trans Med Imaging. 2006 Jul;25(7):817–827. doi: 10.1109/tmi.2006.872328. [DOI] [PubMed] [Google Scholar]
- 33.Poludniowski G, Evans PM, Hansen VN, Webb S. An efficient Monte Carlo-based algorithm for scatter correction in keV cone-beam CT. Phys Med Biol. 2009 Jun;54(12):3847–64. doi: 10.1088/0031-9155/54/12/016. [DOI] [PubMed] [Google Scholar]
- 34.Jarry G, Graham SA, Moseley DJ, Jaffray DJ, Siewerdsen JH, Verhaegen F. Characterization of scattered radiation in kV CBCT images using Monte Carlo simulations. Med Phys. 2006 Oct;33(11):4320. doi: 10.1118/1.2358324. [DOI] [PubMed] [Google Scholar]
- 35.Sisniega A, Zbijewski W, Xu J, Dang H, Stayman JW, Yorkston J, Aygun N, Koliatsos V, Siewerdsen JH. High-fidelity artifact correction for cone-beam CT imaging of the brain. Phys Med Biol. 2015 Feb;60(4):1415–1439. doi: 10.1088/0031-9155/60/4/1415. [DOI] [PubMed] [Google Scholar]
- 36.Thing RS, Mainegra-Hing E. Optimizing cone beam CT scatter estimation in egs_cbct for a clinical and virtual chest phantom. Med Phys. 2014 Jun;41(7):71902. doi: 10.1118/1.4881142. [DOI] [PubMed] [Google Scholar]
- 37.Bootsma GJ, Verhaegen F, Jaffray DA. Efficient scatter distribution estimation and correction in CBCT using concurrent Monte Carlo fitting. Med Phys. 2014 Dec;42(1):54–68. doi: 10.1118/1.4903260. [DOI] [PubMed] [Google Scholar]
- 38.Watson PGF, Mainegra-Hing E, Tomic N, Seuntjens J. Implementation of an efficient Monte Carlo calculation for CBCT scatter correction: phantom study. J Appl Clin Med Phys. 2015 Jul;16(4):216–227. doi: 10.1120/jacmp.v16i4.5393. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 39.Xu Y, Bai T, Yan H, Ouyang L, Pompos A, Wang J, Zhou L, Jiang SB, Jia X. A practical cone-beam CT scatter correction method with optimized Monte Carlo simulations for image-guided radiation therapy. Phys Med Biol. 2015 May;60(9):3567–87. doi: 10.1088/0031-9155/60/9/3567. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 40.Siewerdsen JH, Daly MJ, Bakhtiar B, Moseley DJ, Richard S, Keller H, Jaffray DA. A simple, direct method for x-ray scatter estimation and correction in digital radiography and cone-beam CT. Med Phys. 2005 Dec;33(1):187–197. doi: 10.1118/1.2148916. [DOI] [PubMed] [Google Scholar]
- 41.Kachelrieß M, Sourbelle K, Kalender WA. Empirical cupping correction: A first-order raw data precorrection for cone-beam computed tomography. Med Phys. 2006 Apr;33(5):1269–1274. doi: 10.1118/1.2188076. [DOI] [PubMed] [Google Scholar]
- 42.Zhao W, Brunner S, Niu K, Schafer S, Royalty K, Chen G-H. Patient-specific scatter correction for flat-panel detector-based cone-beam CT imaging. Phys Med Biol. 2015 Feb;60(3):1339–1365. doi: 10.1088/0031-9155/60/3/1339. [DOI] [PubMed] [Google Scholar]
- 43.Lewis EE, Miller WF. Computational methods of neutron transport. New York, NY: John Wiley and Sons, Inc; 1984. [Google Scholar]
- 44.Gifford KA, Horton JL, Wareing TA, Failla G, Mourtada F. Comparison of a finite-element multigroup discrete-ordinates code with Monte Carlo for radiotherapy calculations. Phys Med Biol. 2006 May;51(9):2253–2265. doi: 10.1088/0031-9155/51/9/010. [DOI] [PubMed] [Google Scholar]
- 45.Vassiliev ON, Wareing TA, Davis IM, McGhee J, Barnett D, Horton JL, Gifford K, Failla G, Titt U, Mourtada F. Feasibility of a Multigroup Deterministic Solution Method for Three-Dimensional Radiotherapy Dose Calculations. Int J Radiat Oncol Biol Phys. 2008 Sep;72(1):220–227. doi: 10.1016/j.ijrobp.2008.04.057. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 46.Gifford KA, Price MJ, Horton JL, Wareing TA, Mourtada F. Optimization of deterministic transport parameters for the calculation of the dose distribution around a high dose-rate Ir192 brachytherapy source. Med Phys. 2008 May;35(6Part1):2279–2285. doi: 10.1118/1.2919074. [DOI] [PubMed] [Google Scholar]
- 47.Mikell JK, Mourtada F. Dosimetric impact of an I192r brachytherapy source cable length modeled using a grid-based Boltzmann transport equation solver. Med Phys. 2010 Aug;37(9):4733–4743. doi: 10.1118/1.3478278. [DOI] [PubMed] [Google Scholar]
- 48.Zourari K, Pantelis E, Moutsatsos A, Sakelliou L, Georgiou E, Karaiskos P, Papagiannis P. Dosimetric accuracy of a deterministic radiation transport based 192Ir brachytherapy treatment planning system. Part III. Comparison to Monte Carlo simulation in voxelized anatomical computational models. Med Phys. 2012 Dec;40(1):11712. doi: 10.1118/1.4770275. [DOI] [PubMed] [Google Scholar]
- 49.Vassiliev ON, Wareing T, McGhee J, Failla G, Salehpour MR, Mourtada F. Validation of a new grid-based Boltzmann equation solver for dose calculation in radiotherapy with photon beams. Phys Med Biol. 2010 Feb;55(3):581–98. doi: 10.1088/0031-9155/55/3/002. [DOI] [PubMed] [Google Scholar]
- 50.Bush K, Gagne IM, Zavgorodni S, Ansbacher W, Beckham W. Dosimetric validation of Acuros XB with Monte Carlo methods for photon dose calculations. Med Phys. 2011 Mar;38(4):2208–2221. doi: 10.1118/1.3567146. [DOI] [PubMed] [Google Scholar]
- 51.Fogliata A, Nicolini G, Clivio A, Vanetti E, Mancosu P, Cozzi L. Dosimetric validation of the Acuros XB Advanced Dose Calculation algorithm: fundamental characterization in water. Phys Med Biol. 2011 Mar;56(6):1879–1904. doi: 10.1088/0031-9155/56/6/022. [DOI] [PubMed] [Google Scholar]
- 52.Fogliata A, Nicolini G, Clivio A, Vanetti E, Cozzi L. Critical Appraisal of Acuros XB and Anisotropic Analytic Algorithm Dose Calculation in Advanced Non-Small-Cell Lung Cancer Treatments. Int J Radiat Oncol. 2012 Aug;83(5):1587–1595. doi: 10.1016/j.ijrobp.2011.10.078. [DOI] [PubMed] [Google Scholar]
- 53.Sun M, Maslowski A, Davis I, Wareing T, Failla G, Star-Lack J. Rapid scatter estimation for CBCT using the Boltzmann transport equation. SPIE Medical Imaging. 2014:90330Z. [Google Scholar]
- 54.Maslowski A, Sun M, Wang A, Davis I, Wareing T, Star-Lack J, McGhee J, Failla G, Barnett A. AcurosCTS: A Scatter Prediction Algorithm for Cone-Beam Tomography. American Nuclear Society: Mathematics & Computations (ANS M&C) 2015:1–15. [Google Scholar]
- 55.Wang A, Maslowski A, Messmer P, Lehmann M, Strzelecki A, Yu E, Paysan P, Brehm M, Munro P, Star-Lack J, Seghers D. Acuros CTS: A fast, linear Boltzmann transport equation solver for computed tomography scatter – Part II: System modeling, scatter correction, and optimization. Med Phys. doi: 10.1002/mp.12849. [DOI] [PubMed] [Google Scholar]
- 56.Report 85: Fundamental Quantities and Units for Ionizing Radiation. J Int Comm Radiat Units Meas. 2011;11(1) doi: 10.1093/jicru/ndr011. [DOI] [PubMed] [Google Scholar]
- 57.Hubbell JH, Veigele WJ, Briggs EA, Brown RT, Cromer DT, Howerton RJ. Atomic form factors, incoherent scattering functions, and photon scattering cross sections. J Phys Chem Ref Data. 1975 Jul;4(3):471–538. [Google Scholar]
- 58.Macfarlane R, Muir D, Boicourt R, Kahler A, III, Conlin J. (Los Alamos Natl Lab, no LA-UR-17-20093).The NJOY Nuclear Data Processing System, Version 2016. 2016 [Google Scholar]
- 59.Biggs F, Lighthill R. Analytical approximations for x-ray cross sections III. Sandia Natl Lab. 1988;SAND87(70) [Google Scholar]
- 60.Case K, Zweifel P. Linear transport theory. Reading, MA: Addison-Wesley; 1967. [Google Scholar]
- 61.Adams ML, Larsen EW. Fast iterative methods for discrete-ordinates particle transport calculations. Prog Nucl Energy. 2002 Jan;40(1):3–159. [Google Scholar]
- 62.Siddon RL. Prism representation: a 3D ray-tracing algorithm for radiotherapy applications. Phys Med Biol. 1985;30(8):817–824. doi: 10.1088/0031-9155/30/8/005. [DOI] [PubMed] [Google Scholar]
- 63.Lathrop K, Carlson B. Numerical solution of the Boltzmann Transport Equation. J Comput Phys. 1966 Nov;1(2):173–197. [Google Scholar]
- 64.Larsen E, Miller WF., Jr Convergence Rates of Spatial Difference Equations for the Discrete-Ordinates Neutron Transport Equations in Slab Geometry. Nucl Sci Eng. 1980 Jan;73(1):76–83. [Google Scholar]
- 65.Wareing TA, McGhee JM, Morel JE, Pautz SD. Discontinuous Finite Element SN Methods on Three-Dimensional Unstructured Grids. Nucl Sci Eng. 2001 Jul;138(3):256–268. [Google Scholar]
- 66.Agostinelli S, Allison J, Amako K, Apostolakis J, Araujo H, Arce P, Asai M, Axen D, Banerjee S, Barrand G, Behner F, Bellagamba L, Boudreau J, Broglia L, Brunengo A, Burkhardt H, Chauvie S, Chuma J, Chytracek R, Cooperman G, Cosmo G, Degtyarenko P, Dell’Acqua A, Depaola G, Dietrich D, Enami R, Feliciello A, Ferguson C, Fesefeldt H, Folger G, Foppiano F, Forti A, Garelli S, Giani S, Giannitrapani R, Gibin D, Gómez Cadenas JJ, González I, Abril G Gracia, Greeniaus G, Greiner W, Grichine V, Grossheim A, Guatelli S, Gumplinger P, Hamatsu R, Hashimoto K, Hasui H, Heikkinen A, Howard A, Ivanchenko V, Johnson A, Jones FW, Kallenbach J, Kanaya N, Kawabata M, Kawabata Y, Kawaguti M, Kelner S, Kent P, Kimura A, Kodama T, Kokoulin R, Kossov M, Kurashige H, Lamanna E, Lampén T, Lara V, Lefebure V, Lei F, Liendl M, Lockman W, Longo F, Magni S, Maire M, Medernach E, Minamimoto K, Mora de Freitas P, Morita Y, Murakami K, Nagamatu M, Nartallo R, Nieminen P, Nishimura T, Ohtsubo K, Okamura M, O’Neale S, Oohata Y, Paech K, Perl J, Pfeiffer A, Pia MG, Ranjard F, Rybin A, Sadilov S, Salvo E Di, Santin G, Sasaki T, Savvas N, Sawada Y, Scherer S, Sei S, Sirotenko V, Smith D, Starkov N, Stoecker H, Sulkimo J, Takahata M, Tanaka S, Tcherniaev E, Safai Tehrani E, Tropeano M, Truscott P, Uno H, Urban L, Urban P, Verderi M, Walkden A, Wander W, Weber H, Wellisch JP, Wenaus T, Williams DC, Wright D, Yamada T, Yoshida H, Zschiesche D. Geant4—a simulation toolkit. Nucl Instruments Methods Phys Res Sect A Accel Spectrometers, Detect Assoc Equip. 2003;506(3):250–303. [Google Scholar]
- 67.Cullen D, Hubbell J, Kissel L. EPDL97: the Evaluated Photon Data Library, ’97. Livermore, CA: 1997. Version. [Google Scholar]
- 68.Salvat F, Fernandez-Varea J, Sempau J. PENELOPE-2008: A Code System for Monte Carlo Simulation of Electron and Photon Transport. OECD Nuclear Energy Agency Workshop Proceedings. 2008 [Google Scholar]
- 69.Wang AS, Maslowski A, Wareing T, Schmidt T, Star-Lack J. Patient-Specific Dose Maps for CT Scans Using a Fast, Deterministic Boltzmann Transport Equation Solver. AAPM Annual Meeting. 2015;42(6Part44):3745–3745. [Google Scholar]
- 70.McCollough CH, Leng S, Yu L, Cody DD, Boone JM, McNitt-Gray MF. CT Dose Index and Patient Dose: They Are Not the Same Thing. Radiology. 2011 May;259(2):311–316. doi: 10.1148/radiol.11101800. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 71.Bankier AA, Kressel HY. Through the Looking Glass Revisited: The Need for More Meaning and Less Drama in the Reporting of Dose and Dose Reduction in CT. Radiology. 2012 Oct;265(1):4–8. doi: 10.1148/radiol.12121145. [DOI] [PubMed] [Google Scholar]
Associated Data
This section collects any data citations, data availability statements, or supplementary materials included in this article.