Skip to main content
Medical Physics logoLink to Medical Physics
. 2018 Apr 6;45(5):1899–1913. doi: 10.1002/mp.12850

Acuros CTS: A fast, linear Boltzmann transport equation solver for computed tomography scatter – Part I: Core algorithms and validation

Alexander Maslowski 1, Adam Wang 1,, Mingshan Sun 1, Todd Wareing 1, Ian Davis 1, Josh Star‐Lack 1
PMCID: PMC5948176  NIHMSID: NIHMS948726  PMID: 29509970

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: (a) Ray tracing photons from the x‐ray source into the object where they experience their first scattering event and form scattering sources. (b) 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 using the source iteration method. (c) 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 the 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: (a) a water phantom containing lung, air, and bone inserts (WLAB phantom) and (b) a pelvis phantom derived from a clinical CT dataset. For these studies, we modeled the TrueBeam® (Varian Medical Systems, Palo Alto, CA) kV imaging system with a source energy of 125 kVp. 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 s 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.

Keywords: cone‐beam CT, deterministic calculation, discrete ordinates, finite element, Monte Carlo, scatter

1. Introduction

Cone‐beam CT (CBCT) has proven to be an invaluable clinical tool in the areas of radiotherapy, interventional procedures, and dentistry.1, 2, 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 dose8, 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 modulation12, 13 or blocking,14, 15, 16, 17, 18, 19, 20, 21, 22 (b) scatter deconvolution,23, 24, 25, 26, 27 (c) utilizing a priori knowledge of the object,28, 29, 30 (d) Monte Carlo modeling,31, 32, 33, 34, 35, 36, 37, 38, 39 or (e) other empirical approaches.40, 41, 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).

Figure 1.

Figure 1

Reconstructed cone‐beam CT images of a clinical pelvis scan. Severe shading is seen when no scatter correction is applied. Even after kernel‐based (fASKS) scatter correction, some residual scatter artifact remains, including shading in the bladder (arrows). Display window [−300, 300] HU. [Color figure can be viewed at wileyonlinelibrary.com]

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 buildup 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, 45, 46, 47, 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, 50, 51, 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.

2. Materials and methods

The flow of photons during a CBCT projection can be organized overall into three steps: (a) photons travel from the x‐ray source to the object, where they (b) interact and scatter, possibly multiple times, before (c) 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.

Figure 2.

Figure 2

Overview of the computational algorithm in Acuros CTS. Photons depart the source and arrive into the object in step 1 (red), where they scatter one or multiple times in step 2 (orange) to finally arrive at the detector panel in step 3 (green). [Color figure can be viewed at wileyonlinelibrary.com]

  1. Ray trace photons from the x‐ray source to the object.

  2. Compute the interaction of photons with the object.

  3. 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:

Ω^·ϕΩE(r,E,Ω^)+μt(r,E)ϕΩE(r,E,Ω^)=S(r,E,Ω^)+0E0dE4πdΩμs(r,EE,Ω^Ω^)ϕΩE(r,E,Ω^), (1)

where

  • ϕ ΩE is the angular fluence (sometimes referred to as angular flux) which quantifies the tracks of particles in a differential volume dV about position r 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 m−2 sr−1 J−1.

  • S is a source of photons to the LBTE. The photon source describes the number of photons inserted into position r with energy E traveling along direction Ω^. The unit of the photon source term is m−3 sr−1 J−1. The maximum energy of all sources in the system is E 0.

  • μs(r,EE,Ω^Ω^) is a linear directional scatter coefficient (sometimes referred to as the directional scattering macroscopic cross section) that describes the fraction of photons having energy E travelling along direction Ω^ that scatter into a new direction Ω^ with a new energy E. μ s 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 μ s 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 m−1 sr−1 J−1.

  • μ t 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 m −1. 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:

  1. The first term in Eq. (1) is a projection of the gradient of the angular fluence distribution ϕΩE(r,E,Ω^). Ω^·ϕΩE accounts for how x‐rays stream across a differential volume.

  2. 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.

  3. 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.

  4. The fourth term describes scattering interactions that can increase the angular fluence along the direction Ω^.

The LBTE states that for a given position r 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 r with direction Ω^ (fourth term). The spatially dependent object material and density maps, which form both μt(r,E) and μs(r,EE,Ω^Ω^), are assumed to be known a priori, for example, 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 ϕ ΩE 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 μ s and μ t , 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.

2.A. Continuous domains (r,E,Ω^)

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 2.B, we show how the problem is discretized and the Acuros solver implemented.

2.A.1. Source‐to‐object ray trace

In Acuros’ first step, we trace photons as they depart from the x‐ray source S (0), 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:

Ω^·ϕΩEUC(r,E,Ω^)=S(0)(EΩ^)·δ(rr0)μt(r,E)ϕΩEUC(r,E,Ω^), (2)

where S (0) is the source that drives the uncollided problem (in units of sr−1 J−1) and is defined on a singular point in space — that is, the focal point of our beam r0 from which x‐rays emanate. We can analytically solve for the uncollided ϕΩEUC since all uncollided photons arrive to any point r from a single position r0:

ϕΩEUC(r,E)=S(0)E,Ω^UCrr02exp0rr0dlμtr0+lΩ^UC,E. (3)

Here r is an evaluation point inside the object, Ω^UC is a unit vector pointing in the streaming direction from the x‐ray source located at r0 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 S(0)E,Ω^UC. 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 rr02 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:

SFC(r,E,Ω^)=EE0dE4πdΩ^μs(r,EE,Ω^Ω^)ϕΩEUC(r,E)·δ(Ω^Ω^UC). (4)

We note that since E  ≥ E, this energy integral assumes that photons cannot gain energy from scattering events. Particles arrive to r from the uncollided direction Ω^UC 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.

2.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 Eq. (4) is, by nature (e.g., as described by Thompson and Klein–Nishina scattering equations57), forward peaked along the direction Ω^UC, 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 ϕ ΩE from all streaming directions, Ω′:

Ω^·ϕΩEC(r,E,Ω^)=SFC(r,E,Ω^)+0E0dE4πdΩ[μs(r,EE,Ω^Ω^)ϕΩEC(r,E,Ω^)]μt(r,E)ϕΩEC(r,E,Ω^). (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:

ϕΩEC=n=1ϕΩE(n), (6)

where n is the number of collisions that each generation of the angular fluence has encountered. That is, ϕΩE(1) is the angular fluence of particles that has scattered only once with the object, ϕΩE(2) is the twice‐scattered fluence, etc. We ignore ϕΩE(0) because this is the angular fluence of uncollided particles ϕΩEUC, which we have already addressed (step 1).

SI solves each generation n of the angular fluence distribution sequentially. First, we solve ϕΩE(1), then ϕΩE(2), 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:

Ω^·ϕΩE(n)(r,E,Ω^)=S(n)(r,E,Ω^)μt(r,E)ϕΩE(n)(r,E,Ω^), (7)

where ϕΩE(n) is the unknown angular fluence and S (n) is the amount of (scattered) particles emerging from their nth collision:

S(n)(r,E,Ω^)=0E0dE4πdΩμs(r,EE,Ω^Ω^)ϕΩE(n1)(r,E,Ω^). (8)

Here, ϕΩE(n1) 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):

ϕΩEC=n=1ϕΩE(n)n=1NϕΩE(n). (9)

We apply a convergence criteria <0.1% change between iterations, which in our experience, requires only a modest number of iterations (typically 10 < N < 15) 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:

SMC(r,E,Ω^)=n=2NS(n)(r,E,Ω^). (10)

2.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 ϕΩED(rD,E,Ω^) at detector point rD for those particles arriving with direction Ω^ along the line l is:

ϕΩED(rD,E,Ω^)=0dl[SFC+SMC](rDlΩ^,E,Ω^)exp0ldlμt(rDlΩ^,E)l2. (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. (12) 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 S(rD) is then the integral of the fluence ϕΩED over all energies and angles, weighted by the grid and detector responses:

S(rD)=0E0dE4πdΩϕΩED(rD,E,Ω^)G(rD,E,Ω^)D(rD,E,Ω^), (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 ϕΩED over all angles, we ensure that the contributions from the entire object volume is collected.

2.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:

P(rD)=0E0dES(0)(E,Ω^P)rDr02exp0rDr0dlμt(r0+lΩ^P,E)G(rD,E,Ω^P)D(rD,E,Ω^P), (13)

where Ω^P=(rDr0)/rDr0 is the direction of a primary ray from the point source position r0 to detector position rD.

2.B. Discrete domains (ri,Eg,Ω^m)

The expressions in Section 2.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:

ϕΩ,i,g(Ω^)Eg+1/2Eg1/2dEϕΩE,i(E,Ω^), (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 E g  ∈ [E + 1/2E − 1/2]. 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 six 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.

2.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:

ϕΩ,i,gUC(Ω^UC)=Sg(0)(r0,Ω^UC)rir02expiμt;i,g·li. (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 μ t;g 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 (li) 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:

Si,gFC(Ω^)=g=1gμs;i,gg(Ω^UCΩ^)ϕΩ,i,gUC(Ω^UC). (16)

Here, Si,gFC is the first‐collided scatter source, μs;i,gg is the group‐collapsed linear scatter coefficient from group g′ into group g inside voxel i, and ϕΩ,i,gUC is the uncollided angular fluence. Note that the downscatter energy integral has been replaced by a summation of down‐scattering groups.

2.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. (9), 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 r 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 Ω^m that span 4π.43, 63 The multiple‐collision integral for the nth Source Iteration becomes:

Si,g(n)(Ω^m)=g=1gm=1Mwmμs;i,gg(Ω^mΩ^m)ϕΩ,i,g,m(n1). (17)

Here, ϕΩ,i,g,m(n1) is the collided angular fluence along direction Ω^m. The multiple‐collision source angular integral is now approximated by a quadrature integral, where each direction Ω^m is assigned a quadrature weight w m for its evaluation. In addition, μs;i,gg is the scattering coefficient from energy group g′ to group g and from direction Ω^m into direction Ω^m. 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 O(I 2) 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 O(MI) algorithm (with M ≪ I). The set of streaming directions Ω^m and their corresponding weights w m are preselected 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 μs;i,gg can be simplified by condensing the discrete directions Ω^mΩ^m into a single variable ηm,m=Ω^m·Ωm, 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 Ω^m relative to the incoming one, Ω^m. We exploit this simplification to represent scattering coefficient sections with a Legendre series P l :

μs;i,gg(Ω^mΩ^m)=μs;i,gg(ηm,m)2πl=0L2l+14πμs;i,gglPl(ηm,m). (18)

Here μs;i,ggl 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:

ϕΩ,i,g,ml=0Lk=llζi,gl,kYl,k(Ω^m), (19)

where Y l,k are Spherical Harmonics functions of degree l and order k, and ζi,gl,k 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:

ζi,gl,k=4πdΩYl,k*(Ω^)ϕΩ,i,g(Ω^)m=1MwmYl,k*(Ω^m)ϕΩ,i,g,m, (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. (19), and the Spherical Harmonics expansion of the fluence, Eq. (20), into the scatter source, Eq. (18). The result is:

Si,g(n)(Ω^)=g=1gl=0Lμs;i,gglk=llζi,g(n1);l,kYl,k(Ω^), (21)

which, like the angular fluence, is also represented by spherical harmonic functions. The derivation can be found in the Appendix A and reference.43

Next, we apply the Linear Discontinuous (LD) finite element method64, 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 in the angular fluence within a voxel with a set of first‐order polynomials and provides a framework to evaluate its unknowns:

ϕΩ,i,g,m(r)ϕΩ,i,g,m0+ϕΩ,i,g,mx·P1(xi)+ϕΩ,i,g,my·P1(yi)+ϕΩ,i,g,mz·P1(zi). (22)

Here, P 1 is a linear Legendre polynomial, x i , y i , and z i are spatial coordinates of point r in a coordinate system local to voxel i, and ϕΩ,i0,ϕΩ,ix,ϕΩ,iy and ϕΩ,iz 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 ϕ Ωi across all voxels that define the complete LD solution to the LBTE.

To compute the LD angular fluence amplitudes, we project the LBTE into the LD solution space {1, P 1(·)}, the details of which are in the Appendix B. As a result, this spatial discretization produces a system of four equations (one for each weighted moment of the LBTE) and four 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 nonphysical, the LD method is said to superconverge since volume integrals of its solution exhibit quadratic convergence (or a cubic error) of a solution built on linear polynomials. Armed with a superconvergent 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 its 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 4 × I × G × M 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 (four 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:

ζi,gC;l,k=m=1MwmYl,k*(Ω^m)n=1NϕΩ,i,g,m(n)(r), (23)

and compute the multiple‐collision source in the direction Ω^:

Si,gMC(r,Ω^)=g=1gl=0Lμs;i,gglk=llζi,gC;l,k(r)Yl,k(Ω^). (24)

2.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:

ϕΩ,i,gD(r,rd)=SgFC+SgMC(r,Ω^d)expiμt;i,g·lirdr2. (25)

Here, ϕΩ,i,gD is the angular fluence of group g arriving at point rd in the detector pixel. Ω^d is the streaming direction pointing from r to rd, and r 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 (i′) each ray intersects and the length of each voxel intersection (li).

The contribution of ϕΩ,i,gD to the scatter signal is:

Si,g(r,rd)=ϕΩ,i,gD(r,rd)·Gg(Ω^d)·Dg(Ω^d), (26)

where Si,g(r,rd) is the contribution to the scatter signal from point r in voxel i to point rd in the panel. The grid and detector responses have been simplified, as described below in Section 2.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 ri,j are quadrature points (j) inside voxel i, and w j 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:

Su=dwd·g=1Gi=1Ijwj·ϕΩ,i,gD(ri,j,rd)·Gg(Ω^i,jd)·Dg(Ω^i,jd), (27)

where w d and rd are the quadrature weights and points, respectively, that numerically integrate the area of the pixel.

2.B.4. Computation of primary

The computation of the primary signal in a pixel (P u ) closely mimics its analytic counterpart. We apply pixel subsampling, our group structure, and simplified anti‐scatter grid and detector models:

Pu=dwd·g=1GSg(0)(Ω^p)expiμt;i,g·lirdr02Gg(Ω^p)·Dg(Ω^p). (28)

Here, Sg(0)(Ω^p) is beam strength of group g along the primary direction Ω^p. Each primary ray is traced from the beam's focal point to rd 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 w d and rd form the spatial quadrature that integrates the area of pixel u.

2.C. Generating the grid and detector responses

The generalized grid and detector responses can be difficult to model if they are dependent on all three 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 (θ 1, θ 2), where θ 1 is with respect to the focusing direction in the v‐source plane and θ 2 is with respect to the normal direction in the u‐source plane (Fig. 3). The grid response is then simplified to:

Gg(Ω^)=Gg(θ1,θ2). (29)

Figure 3.

Figure 3

(a) Simplified grid response for focused 1D grid and (b) simplified detector response. [Color figure can be viewed at wileyonlinelibrary.com]

Therefore, a 2D lookup table (LUT) in (θ 1, θ 2) for each energy group g is sufficient to characterize G. The response was precomputed 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 (θ 1, θ 2) 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 nonperpendicular rays:

Dg(Ω^)=Dg(θ0). (30)

Accordingly, D can be represented as a 1D LUT in θ 0 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 θ 0 to determine D g . It was then assumed the detected signal (analog–digital units, ADU) is proportional to the energy deposited.

2.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. 4(a)] 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. 4(a) 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 six 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 precomputed 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 cutoff 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.

Figure 4.

Figure 4

(a) Digital WLAB phantom showing dimensions of water (W) and lung (L), air (A), and bone (B) inserts. (b) Imaging geometry, as viewed from above. All dimensions are in centimeters. The phantom extends ±20 cm in/out of the page, while the detector extends ±15 cm in/out of the page. [Color figure can be viewed at wileyonlinelibrary.com]

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 into 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 downsampled 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. As downsampling was performed by an integer factor, the downsampled 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.

Figure 5.

Figure 5

Multiplanar reformat of a digital pelvis phantom on an IGRT table, showing water and bone densities. Display window [0, 2] g/cm3.

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).

3. Results

3.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 −0.2% and −0.7%, respectively. As the results are normalized to one photon/steradian at the source, the fluence at the detector is on the order of 10−8 photons/mm2.

Figure 6.

Figure 6

WLAB phantom primary and scatter images of fluence at the detector, comparing Geant4 and Acuros. Primary images shown on [0, 2 × 10−8] photons/mm2, scatter images shown on [4 × 10−9, 8 × 10−9] photons/mm2 window. Horizontal line profiles are taken across the central row. [Color figure can be viewed at wileyonlinelibrary.com]

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:

SF=S/(P+S). (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 −0.1% without the grid and 0.6% 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.

Figure 7.

Figure 7

Scatter fraction line profiles for WLAB phantom, using energy deposited in the CsI scintillator, for cases without and with a 10:1 grid. [Color figure can be viewed at wileyonlinelibrary.com]

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 s using a single GPU for an object comprising 24,000 voxels. For the Geant4 simulation, 4 × 1010 source photons were launched, with the computation taking ~1,200 CPU‐h 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.

3.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 4 × 1010 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%.

Figure 8.

Figure 8

(a) Orientation of 0° (AP) and 270° (lateral) projections relative to patient. Geometry not to scale. (b) Primary and scatter images of energy deposited in the detector for Geant4 and Acuros for the 0° projection. Primary images are shown on the same log scale, while the scatter images are shown on the same linear scale. (c) Horizontal line profiles of scatter fraction across central row. [Color figure can be viewed at wileyonlinelibrary.com]

4. 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 not only 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 s/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. Hence, 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

5. 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.

Conflict of Interest

All authors were employees of Varian Medical Systems.

Supporting information

Table S1. Source spectrum.

Table S2. Geant4 line profiles for WLAB phantom.

Table S3. WLAB phantom material definitions.

 

Acknowledgments

The authors 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. (18), we find:

Si,g(Ω^m)=g=1gm=1Mwml=0L2l+14πμs;i,gglPl(ηm,m)l=0Lk=llζi,gl,kYl,k(Ω^m). (A1)

Therefore, to evaluate the scattering source in direction Ω^m, 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:

Pl(Ω^m·Ω^m)=4π2l+1k=1lYl,k(Ω^m)Yl,k*(Ω^m), (A2)

Furthermore, we reorganize the scattering source terms to take advantage of the orthogonality of Spherical Harmonics functions:

Si,g(Ω^m)=g=1gl=0Lμs;i,gglk=1lYl,k(Ω^m)l=0Lk=llζi,gl,km=1MwmYl,k*(Ω^m)Yl,k(Ω^m), (A3)

where Yl,k*(Ω^m) and Yl,k(Ω^m) are orthogonal functions:

m=1MwmYl,k*(Ω^m)Yl,k(Ω^m)=δk,kδl,l. (A4)

Here, M is large enough, so that it exactly integrates spherical harmonic functions of degree l, l′, and order k, k′ thus reducing the scatter source expression to Eq. (22).

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 P 1(x i ) projection is:

VidS·(N^·Ω^m)·P1(xi)·ϕΩ,i,g,m(n)(r)VidV·[Ω^·P1(xi)]·ϕΩ,i,g,m(n)(r)=VidV·Sg,m(n)(r)·P1(xi)μt;i,g·ϕΩ,i,g,m(n);xVidV·[P1(xi)]2. (B1)

Here, we have integrated the LBTE of the nth source iterate of the collided fluence, ϕΩ,i,g,m(n). The integral was weighted by the P 1(x i ) 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. N^ is a vector normal to the voxel's surfaces that points outward. 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:

VidV·Sg,m(n)(r)·P1(xi)=g=1gμs;i,gg(Ω^UCΩ^m)n=0,j=1Jwj·ϕΩ,gUC(rj,Ω^UC)·P1(xij);g=1gl=0Lμs;i,gglk=llζi,g(n1);l,k,x·Yl,k(Ω^m)·n>0VidV·[P1(xi)]2; (B2)

where we have integrated the P 1(x i ) moment of Sg,m(n), the source of the nth 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 (n = 0). 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 rj and weights w j . The second integrand evaluates the P 1 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;53:1337–1349. [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;19:814–820. [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: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;28:469–474. [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;28:220–231. [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;38:4296–4311. [DOI] [PubMed] [Google Scholar]
  • 7. Rührnschopf E‐P, and Klingenbeck K. A general framework and review of scatter correction methods in cone beam CT. Part 2: scatter estimation approaches. Med Phys. 2011;38:5186–5199. [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;36:22–32. [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;34:2691–2703. [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;31:3506–3520. [DOI] [PubMed] [Google Scholar]
  • 11. Sisniega A, Zbijewski W, Badal A, et al. Monte Carlo study of the effects of system geometry and antiscatter grids on cone‐beam CT scatter distributions. Med Phys. 2013;40:51915. [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;25:1573–1587. [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;37:934–946. [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;31:1195–1202. [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;36:2258–2268. [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;39:2386–2395. [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;37:5792–5800. [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;38:6027–6038. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 19. Jin J‐Y, Ren L, Liu Q, et al. Combining scatter reduction and correction to improve image quality in cone‐beam computed tomography (CBCT). Med Phys. 2010;37:5634–5644. [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;59:6487–6505. [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;42:6625. [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;40:71903. [DOI] [PubMed] [Google Scholar]
  • 23. Love LA, Kruger RA. Scatter estimation for a digital radiographic system using convolution filtering. Med Phys. 1987;14:178–185. [DOI] [PubMed] [Google Scholar]
  • 24. Seibert JA, Boone JM. X‐ray scatter removal by deconvolution. Med Phys. 1988;15:567–575. [DOI] [PubMed] [Google Scholar]
  • 25. Sun M, Star‐Lack JM. Improved scatter correction using adaptive scatter kernel superposition. Phys Med Biol. 2010;55:6695–6720. [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:2058–2073. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 27. Stankovic U, Ploeger LS, van Herk M, Sonke J‐J. Optimal combination of anti‐scatter grids and software correction for CBCT imaging. Med Phys. 2017;44:4437–4451. [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;37:5395–5406. [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. 2008;53:5719–5733. [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;39:1991–2000. [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;23:584–590. [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;25:817–827. [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;54:3847–64. [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;33:4320. [DOI] [PubMed] [Google Scholar]
  • 35. Sisniega A, Zbijewski W, Xu J, et al. High‐fidelity artifact correction for cone‐beam CT imaging of the brain. Phys Med Biol. 2015;60:1415–1439. [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;41:71902. [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;42:54–68. [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;16:216–227. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 39. Xu Y, Bai T, Yan H, et al. A practical cone‐beam CT scatter correction method with optimized Monte Carlo simulations for image‐guided radiation therapy. Phys Med Biol. 2015;60:3567–3587. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 40. Siewerdsen JH, Daly MJ, Bakhtiar B, et al. A simple, direct method for x‐ray scatter estimation and correction in digital radiography and cone‐beam CT. Med Phys. 2005;33:187–197. [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;33:1269–1274. [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;60:1339–1365. [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;51:2253–2265. [DOI] [PubMed] [Google Scholar]
  • 45. Vassiliev ON, Wareing TA, Davis IM, et al. Feasibility of a multigroup deterministic solution method for three‐dimensional radiotherapy dose calculations. Int J Radiat Oncol Biol Phys. 2008;72:220–227. [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;35:2279–2285. [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;37:4733–4743. [DOI] [PubMed] [Google Scholar]
  • 48. Zourari K, Pantelis E, Moutsatsos A, et al. 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;40:11712. [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;55:581–598. [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;38:2208–2221. [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;56:1879–1904. [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;83:1587–1595. [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. in SPIE Medical Imaging; 2014, p. 90330Z.
  • 54. Maslowski A, Sun M, Wang A, et al. AcurosCTS: A Scatter Prediction Algorithm for Cone‐Beam Tomography. in American Nuclear Society: Mathematics & Computations (ANS M&C); 2015, pp. 1–15.
  • 55. Wang A, Maslowski A, Messmer P, et al. Acuros CTS: a fast, linear Boltzmann transport equation solver for computed tomography scatter – Part II: system modeling, scatter correction, and optimization. Med Phys. 2018;45:1914–1925. [DOI] [PubMed] [Google Scholar]
  • 56. International Commission on Radiation Units and Measurements . Report 85: fundamental quantities and units for ionizing radiation. J Int Comm Radiat Units Meas. 2011;11:1–31. [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;4:471–538. [Google Scholar]
  • 58. Macfarlane R, Muir D, Boicourt R, Kahler A III, Conlin J. The NJOY Nuclear Data Processing System, Version 2016. Los Alamos Natl. Lab., no. LA‐UR‐17‐20093; 2016.
  • 59. Biggs F, Lighthill R. Analytical approximations for x‐ray cross sections III. Sandia Natl. Lab., vol. SAND87, no. 70; 1988.
  • 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;40:3–159. [Google Scholar]
  • 62. Siddon RL. Prism representation: a 3D ray‐tracing algorithm for radiotherapy applications. Phys Med Biol. 1985;30:817–824. [DOI] [PubMed] [Google Scholar]
  • 63. Lathrop K, Carlson B. Numerical solution of the Boltzmann transport equation. J Comput Phys. 1966;1: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;73: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;138:256–268. [Google Scholar]
  • 66. Agostinelli S, Allison J, Amako K, et al. Geant4—a simulation toolkit. Nucl Instrum Methods Phys Res Sect A Accel Spectr Detect Assoc Equip. 2003;506:250–303. [Google Scholar]
  • 67. Cullen D, Hubbell J, Kissel L. EPDL97: the Evaluated Photon Data Library, 97 Version. Livermore, CA; 1997.
  • 68. Salvat F, Fernandez‐Varea J, Sempau J. PENELOPE‐2008: A Code System for Monte Carlo Simulation of Electron and Photon Transport. in OECD Nuclear Energy Agency Workshop Proceedings; 2008.
  • 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. in AAPM Annual Meeting; 2015, vol. 42(6Part44), pp. 3745–3745.
  • 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;259:311–316. [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;265:4–8. [DOI] [PubMed] [Google Scholar]

Associated Data

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

Supplementary Materials

Table S1. Source spectrum.

Table S2. Geant4 line profiles for WLAB phantom.

Table S3. WLAB phantom material definitions.

 


Articles from Medical Physics are provided here courtesy of American Association of Physicists in Medicine

RESOURCES