This application for patent incorporates by reference the following:
U.S. patent application Ser. No. 11/465,717 and PCT patent application Ser. No. PCT/US2006/0032393, both filed Aug. 18, 2006, and entitled “Image Synthesis Methods and Systems.”
U.S. patent application Ser. No. 11/474,091 and PCT patent application Ser. No. PCT/US2006/0024820, both filed Jun. 23, 2006, and entitled “Image Synthesis by Rank-1 Lattices.”
U.S. patent application Ser. No. 10/299,958, filed Nov. 19, 2002, entitled “System and Computer-Implemented Method for Evaluating Integrals Using a Quasi-Monte Carlo Methodology in Which Sample Points Represent Dependent Samples Generated Using a Low-Discrepancy Sequence.”
U.S. patent application Ser. No. 10/439,311, filed May 15, 2003, entitled “System and Computer-Implemented Method for Evaluating Integrals Using Stratification by Rank-1 Lattices.”
U.S. patent application Ser. No. 08/880,418, filed Jun. 23, 1997, now U.S. Pat. No. 6,529,193, entitled “System and Method for Generating Pixel Values for Pixels in an Image Using Strictly Deterministic Methodologies for Generating Sample Points.”
The present invention relates generally to methods and systems for image synthesis in and by digital computing systems, such as for motion pictures and other computer graphics applications, and in particular, relates to methods, systems, devices, and computer program products adapted to enable finite element light transport simulation in computer graphics systems.
The use of synthetic images has become increasingly important and widespread in motion pictures and other commercial and scientific applications. A synthetic image represents a two-dimensional array of digital values, called picture elements or pixels, and thus can be regarded as a two-dimensional function. Image synthesis, then, is the process of creating synthetic images from scenes. Image synthesis conventionally requires solving equations requiring substantial, and in some cases even impractical, levels of computational resources.
Accordingly, it would be desirable to provide improved methods, systems, devices and computer program products adapted for image synthesis.
More particularly, as described in greater detail below, it would be desirable to provide such methods, systems, devices and computer program products adapted to enable finite element light transport simulation, as well as new and improved radiosity and global illumination methods based on such an approach.
The invention provides systems, apparatus, computer software code products and methods for enabling computer graphics systems to accurately and efficiently render images.
Systems, apparatuses, computer program products and methods in accordance with the invention are suitable for implementation or execution in a computer graphics system for rendering images for storage or for display on a display element, the computer graphics system comprising a computer, the displaying comprising the display of images on the display element, and wherein the rendering of an image comprises utilizing the computer and/or other elements of the computer graphics system to generate pixel values corresponding to pixels in an image representation.
Systems, apparatuses, computer program products or methods in accordance with the present invention are suitable for implementation or execution in, or in conjunction with, a wide range of commercially available computer graphics systems, including (but not limited to), for example, computer graphics products and systems commercially available from MENTAL IMAGES GmbH of Berlin, Germany. (See, for example, the MENTAL RAY product from MENTAL IMAGES GmbH.) The to invention is also suitable for implementation or execution in, or in conjunction with, a wide range of other commercially available computer graphics systems, products, environments, hardware and software that provide rendering functionality. Given the description herein, and the attached drawing figures, one of ordinary skill in the relevant art will understand how the present invention may be so implemented or executed in, or in conjunction with, such commercially available computer graphics systems, products, apparatus or methods.
One aspect of the present invention comprises: (1) constructing a sparse implicit scene representation, wherein the representation is independent of geometric encoding and complexity of the input scene description, and the density of the resulting finite elements is proportional to their contribution to the final image, such that the geometric resolution of a given area of the obtained scene representation is proportional to its importance relative to the final image, (2) wherein the constructing comprises using a Monte Carlo or quasi-Monte Carlo path tracing method to sample an adjoint importance distribution function and to shoot importons from a simulated camera into the scene, recording, for each simulated bounce, a particle i defined by selected information, (3) the selected information comprising: 3D position pi, surface normal ni, and reflectance factor pi.
Another aspect of the invention comprises utilizing the above-noted aspects in combination with the application of any of cell sampling, area and form factor estimates.
Another aspect of the invention comprises further utilizing hierarchical gathering sums.
Yet another aspect of the invention comprises also utilizing hierarchical stochastic sampling.
A further aspect of the invention comprises also utilizing sample warping.
Still another aspect of the invention comprises utilizing importance sampling and evaluating resulting sums utilizing a Monte Carlo or quasi-Monte Carlo quadrature formula.
Another aspect of the invention comprises the utilization of importance-based stratification: and this can comprise utilizing re-sampled importance-based stratification.
A further aspect of the invention comprises computing upper bound estimates: and this aspect can comprise utilizing Monte Carlo or quasi-Monte Carlo sampling.
Additional aspects of the invention, discussed in greater detail below, comprise utilizing hierarchical stochastic radiosity solvers, performing a final gathering operation, and utilizing photon mapping.
These and other aspects will be discussed in greater detail below in the following Detailed Description of the Invention and in connection with the attached drawing figures.
These and other aspects will be discussed in greater detail below in the following Detailed Description of the Invention and in connection with the attached drawing figures.
FIGS. 5 and 6A-6B are schematic block diagrams of conventional digital processing systems suitable for implementing and practicing described aspects of the invention.
The invention will next be described in detail in the following pages, taken in connection with the attached drawing figures. Those skilled in the art will appreciate that various additions, subtractions, and other modifications and implementations of the invention can be practiced, and are within the spirit and scope of the present invention.
As discussed herein, known forms of integrated circuit or semiconductor elements such as ASICS can be implemented in such a manner, using the teachings of the present invention described herein, to carry out the methods of the present invention as shown, for example, in the attached drawings and discussed herein, and to implement modules 10, 20, 30, 40, 50, 60, 70, and 80 within a suitable processing system 100, as shown in
The invention can be described as including aspects of constructing an image representation, using Monte-Carlo or quasi-Monte Carlo path tracing, shooting importons from a simulated camera into the scene: recording, for each bounce of the importons, information for a particle i, defined by 3D position, surface normal and reflectance factor; utilizing or performing cell sampling, area and/or form factor estimates; hierarchical gathering sums; hierarchical stochastic sampling; sample warping; importance-based and re-sampled importance based stratification; computing upper bound estimates; final gathering; and photon mapping.
Each of these aspects and elements will next be discussed in detail in the following pages, which are arranged into the following sections:
The light transport in a scene can be expressed by the following equation:
L(x,ω)=∫ML(y,ωy→x)fr(x,ωy→x,ω)G(x,y,nx,ny)V(x,y)dA(y)+Le(x,ω) (1)
where M is the set of scene surfaces, L is the outgoing radiance, Le the emitted radiance, fr the bidirectional reflectance distribution function (BRDF), V the intervisibility function between a pair of points, and G is the geometric throughput:
G(x,y,nx,ny)=T(nx,y−x)T(ny,x−y)/π|x−y|2 (2)
T (u, v) being the cosine of the angle between u and v if they have the same orientation, zero otherwise.
The goal of light transport algorithms is to compute a set of measurements Ij (typically corresponding to the values of each pixel in an image) defined as:
Ij=∫M×ΩWj(x,ω)L(x,ω)dA(x)cos(θ)dω (3)
where Wj is the response function of the j-th sensor, and θ is the angle between ω and the surface normal at x.
The light transport equation can also be rewritten in compact form as:
L=TL+Le (4)
where T is the linear functional operator defined by:
(TL)(x,ω)=∫ML(y,ωy→x)fr(x,ωy→r,ω) G(x,y,nx,ny)V(x,y)dA(y) (5)
or:
(TL)(x,ω)=∫ΩL(h(x,−ω′)fr(x,ω′,ω)cos(θ′)dω′ (6)
where the integral over the scene surfaces has been replaced by an integral over the sphere of directions Ω, θ′ is the angle between ω′ and nx, and h (x,−ω′) is the first point visible from x in direction −ω′.
Finite elements can be used to represent the radiance function in a finite series
In form:
where bj (x, ω) are a given set of basis functions and Lj are scalar coefficients. Usually, such basis functions are constructed as the product of a set of positional basis functions and a directional one, where the positional basis functions are constant or linear over a set of patches.
With this representation, equation (4) becomes:
which can be further simplified to:
if the basis functions form an orthonormal system (i.e., <bi,bj>=δij).
In the case of purely Lambertian reflection, the directional dependence on ω disappears, bj can be written as bj (x), and T can be defined as:
(TL)(x)=ρ(x)∫ML(y)G(x,y,nx,ny)V(x,y)dA(y) (10)
where ρ(x) is the Lambertian reflection coefficient at x.
Classical radiosity techniques discretize radiosity B=πL and the transport operator over a set of N oriented polygonal patches {Pi:i=1, . . . , N} representing the scene surfaces, and attempt to solve the linear system:
where Tij is now ρiFij and Fij is the geometric form factor between the pair of patches (i,j):
Fij=∫P
Again, in matrix form. this can be more compactly rewritten as:
B=TB+Be. (13)
where T is now the “N×N radiosity matrix.”
Solving the equation directly using dense linear system solvers would be infeasible even for relative small values of N, and hence, several fast iterative solvers have been developed which aimed at reducing the computational time and memory complexity to (N log N) or even
(N).
However, the main limitation of all such techniques is the remaining strong dependence on the input scene description, which needs to be entirely tessellated up front. For large production scenes, where even the sheer amount of polygons needed to faithfully represent subpixel curvature of visible high order and procedurally displaced surfaces only is often more than what can fit in physical memory, this has been proven impractical. Moreover, since light transport is non-local and the accuracy of the resulting solution for any point in space is dependent on the accuracy of the solution of all the other points, standard methods for view-dependent tessellation could no longer be used.
Described herein is a novel framework for radiosity and global illumination techniques based on a sparse implicit scene representation with the following properties:
(1) The obtained representation is independent of the geometric encoding and complexity of the input scene description.
(2) The density of the resulting finite elements is proportional to their contribution to the final image. That is to say, the geometric resolution of a given area of the obtained scene representation is proportional to its importance relative to the final image.
This is achieved by using a Monte Carlo or Quasi-Monte Carlo path tracing method to sample the adjoint importance distribution and shoot importons from the camera into the scene, recording, for each bounce, a particle i defined by the following information:
Now, if it is considered that the 5-dimensional space R3×S2, where R3 represents the space of positions and S2 is the unit sphere of directions, equipped with the Euclidean distance metric:
d((x,nx),(y,ny))=a|x−y|+nx−ny|. (14)
the obtained sparse point cloud is implicitly defining a Voronoi diagram whose cells are given by:
Vil ={(x,n)∈R3×S2: d(x,n),(pi,ni))<d((x,n),(pj,nj))∀j≠i}. (15)
This diagram can be intersected with the scene surfaces to obtain surface cells defined by:
ViM={(x,n)εM:d((x,n),(pi,ni))≦d((x,n), (pi,ni))∀j≠i}. (16)
The free parameter α can be used to control the relative importance of normal versus positional discrepancy, and in our tests it is set to 1/diag ({pi: i=1, . . . , N}).
The surface patches defined implicitly by these cells can be used as the basis needed to apply equations (6), (8) and (10).
The following sections describe in detail a new hierarchical stochastic radiosity technique, a new photon mapping technique, and a new final gathering technique based on this novel framework.
2. Cell Sampling, Area and Form Factor Estimates
Central to any global illumination and radiosity technique operating on finite elements is the computation of integrals on surface patches. For example, radiosity requires the computation of form factors Fij. In the developed framework, this amounts to computing integrals of the form:
I=∫hd π(V
where f is any function defined on and ViM, and π is the canonical 3d projection:
π:R3×S2→R3
(x,n)→x (18)
In order to compute such integrals, an approximation to ViM is developed that allows easy sampling, namely the intersection of Vi with a disc laying on the tangent plane at xi. As the following construction shows, such disc is obtained taking the 3-d bounding sphere of the position component of the vertices of the Voronoi cell Vi and intersecting it with the tangent plane.
For each point pi, let Ti denote the local- tangent plane to M:
Ti−{xεR3: x·ni=pi·ni}. (19)
For each cell Vi, we then consider the 3d sphere Bi(ri)=B(pi,r) centered in pi and passing through the furthest vertex of the projection πi (π(Vi)).
The collection of such spheres form a covering of the convex hull of the points pi. Moreover, for interior cells, Bi(ri) has the property of containing π(Vi) (and hence π (ViM) as well).
Now, if Di(ri) is the disc Ti∩Bi(ri), we consider the following locally flat, finite approximation to ViM:
ViT={xεDi(ri):(x,ni)εVi} (20)
and approximate I with the formula:
I≈∫V
where χi is the characteristic function of ViT (intuitively, ViT is the intersection of the tangent plane Ti with a bounded version of the original 5d Voronoi cell Vi).
In order to compute this integral, it is necessary to be able to evaluate ri and χi. Although it would be theoretically possible to evaluate them exactly by computing the actual vertices of each cell Vi, we just build an approximation using any 5-dimensional nearest neighbor search structure, such as a kd-tree.
Let nnk (x, n) be the function returning the k-th nearest neighbor of (x, n) among {(pi, ni): i=1, . . . , N} and let δi be the function:
δi(x,n)=1∀(x,n):nn1(x,n)=(pi,ni) 0 ∀(x,n): nn1(x,n)≠(pi,ni) (22)
It can be easily proven that δi (x, ni)=χi(x)∀xεTi, and if we assume all Voronoi cells Vi to have less than m vertices, we can bound ri with the 3d distance from pi to its m-th nearest neighbor:
ri≦Ri=|π(nnm(pi,ni))−pi|. (23)
Then, by generating a set Si of M random or quasi-random samples uniformly distributed over the disc Di (Ri) we can approximate the integral of equation (21) by the sum:
For example, the area of each cell can be estimated by:
The same principles can be used to compute form factors. In fact, while for two distant Voronoi cells, these can be estimated by the point-to-point approximation formula:
Fij≈G(pi,pj,ni,nj)V(pi,pj) (26)
For neighboring cells, the error introduced by this approximation can become arbitrarily large due to possible singularities in the integrand, hence, a more accurate approximation is proposed. It is in fact sufficient to generate two sets of samples Si and Sj for ViT and VjT respectively to compute the double integral:
where the visibility term has been treated as a constant, and approximated by the mutual visibility of the cell centers.
The existence of a small bound m on the number of vertices of each cell ViM is also a reasonable assumption. In fact, it can be proven that for any set of points on a 2-dimensional manifold, the average number of vertices of their Voronoi cells is 6. It has been found that 16 is sufficient in most of the cases.
3. Hierarchical Gathering Sums
Let us consider a doubly-indexed set of basis functions bi with i=(i0, i1) defined as the product of the set of positional functions {Xi}i=1 . . . N, and any set of M directional basis functions {dk:Ω→R}k=1 . . . M:
bi(x,ω)=xin(x)dil(ω) (28)
According to equation (9), the equilibrium distribution of radiance can be approximated as the fixed point of the iterative system:
where Ti is interpreted as the i-th row of the transport matrix Tij:
with the “transport kernel” defined as:
Tij(x,ω,y)=bi(x,ω)bj(y,ωy . . . x)fr(x,ωy . . . xω)G(x,y,nx,ny)V(x,y). (31)
Equation (29) can also be written in differential form as:
where Tij(x, ω) is the “element to point” transport function:
Tij(x,ω)=[(Tbj)(x,ω)]bi(x,ω) (33)
and Li(r) is obtained integrating the “differential lighting element” Li(r)(x,ω) over the support of the i-th basis function:
Li(r)=∫V
Similarly, in the context of radiosity and a directionally independent set of basis functions bi=xi, one would need to solve sums of the form:
where the transport matrix becomes:
Tij=∫Vi
and the transport kernel simplifies to:
Tij(x,y)=bi(x)bj(y)ρi(x)G(x,y,nx,ny)V(x,y). (37)
In both cases, the outer summation computes all the light reflected by a given finite element by gathering light arriving from all the other N×M elements. Straight evaluation of such sums would require (N M) time complexity, which would make it infeasible to iteratively compute them for all the finite elements. Hence we propose three new hierarchical stochastic sampling algorithms which allow the evaluation of each sum in
(log (N M)) time.
Let us consider the basis functions bi=χi
Now, consider a bounding volume hierarchy over the product of the set of cells ViT and the directions ωk. A node n in this hierarchy represents a cluster of finite elements, and it can be defined by a 3d bounding box Bn. a bounding cone Cnm for the set of normals contained inside it, and a total outgoing radiance value Ln, corresponding to the sum of the current radiance values of all the cells inside the node.
Given a node n and a basis function i, the total energy transfer from n to i can be expressed both in differential and integral form as:
L
n−1=∫
V
×Ω
L
n . . . i(x,ω)dA(x)dω. (39)
Now, suppose it's possible to quickly compute an upper-bound estimate {circumflex over (L)}n→i for each node n, and each finite element i (there will he described below several techniques for estimating them). For a fixed i, the set of quantities defines a hierarchy of bounds on the energy outgoing from i due to each single node.
The following algorithm uses this hierarchy to perform importance sampling, and evaluate the sum Ti·L using the Monte Carlo or Quasi-Monte Carlo quadrature formula:
where jk is the k-th random or quasi-random sample, and Pjk is its discrete probability.
(·)0:i→┌i/M┌
(·)1:i→i mod M
Additionally, in order to compute Tij
where xk and yk are independent uniformly distributed samples inside the circles Di(Ri) and Djk(Rjk) respectively, and ωk is a direction in Ω sampled according to some probability distribution function Pωk, ideally proportional to di
Alternatively, it's also possible to evaluate Ti·L in its differential form at any given point (x, ω) as:
3.2 Technique 2: Importance-Based Stratification
Similarly to the previous section, we evaluate the sum Ti·L=ΣTijLj using the stochastic approximation formula (40), however, instead of relying on sample stratification in the [0, 1) interval before warping, we now propose a scheme to automatically split the sampling domain, i.e., the cell tree, into several strata containing one sample each, where each stratum is a node whose size is inversely proportional to its importance.
The technique is straightforward. Essentially, the root of the tree is inserted into a priority queue, ordered by the nodes' importance. Then, for each iteration in a loop the top of the tree is extracted. If the node is a leaf, it is inserted into a vector holding the output strata, otherwise it is split, and its children are reinserted into the queue. The loop stops when total number of nodes in the queue plus the number of leaves visited reaches the desired number of strata.
3.3 Technique 3: Resampled Importance Based Stratification
Now, suppose our estimates Ln→i are not very precise, or suppose that the transfers from the individual basis functions inside a node n have high variance. Then, taking a low number of samples S might still not capture all the important details needed for approximating the sum (39) accurately. Moreover, typically the dominant cost in evaluating the contribution of each TijLj is the cost of evaluating the intervisibility function V. Hence, we propose the following resampling strategy.
For a given pair (i, j), we define the “simplified transport functional” {tilde over (T)}ij as:
where:
{tilde over (T)}i(x,ω,y)=bi(x,ω)bj(y,ωy→x)fr(x,ωy→r,ω)G(x,y,nx,ny) (45)
Now, we can use Technique 2 to select R×S strata for some given integer R, Technique 1 to select one sample jk for each stratum k with probability pjk, and then resample S samples {jk(s)}s=1 . . . s out of them using the probability density:
Finally, the sum of equation (4) can now be estimated by:
Vij being the visibility between the cells Vi
3.4 Computing Upper Bound Estimates
In the previous subsections we have assumed it was possible to quickly computer upper bound estimates {circumflex over (L)}n→i for equations (38) and (39). This is possible by decomposing their value into several components:
where {circumflex over (F)}n,i is an upper-bound estimate on the brdf term times the directional basis functions:
bounds the geometric factor from n to any other point:
{circumflex over (V)}n bounds the visibility term:
Now, {circumflex over (V)}n(x) is a Boolean function assuming the values 0 and 1 only. Bounding visibility from a cluster to a point can be done using conservative visibility hierarchies, however, it's also possible to set {circumflex over (V)}n(x)=1 ∀x, n without loss of generality.
On the contrary, the geometric term Gn(x) and the reflection term {circumflex over (F)}n→1 can be bound by further splitting them into subcomponents:
and
Now, the distance between a point and a bounding box, and the bounds on T between a point and a box with an associated cone of normals can all be computed analytically. For the bounds on the basis functions dk and the bidirectional reflectance distribution function (BRDF) term, we can instead use the formulas:
and
where C(x, Bn) is the bounding cone of B(n) seen from the point x. It is important to note that even though equation (49) requires the computation of a maximum over all of the basis functions in n, as a matter of fact the maximum is only restricted to the directional components, which are always less than or equal to M. If close form expressions for such bounds are not available, these can be approximated by Monte Carlo or Quasi-Monte Carlo sampling a finite set of directions {ω′s}s=1 . . . , S in C (x, Bn) and taking the maximum over these.
Finally, the outer integral of equation (48) can be estimated using the cell sampling techniques developed in section 2.
4. Hierarchical Stochastic Radiosity Solvers
Radiosity can be seen as the fixed point of the Jacobi iteration:
which can be performed by the following straightforward algorithm:
In a naïve implementation, each evaluation of ΔBi′ would require evaluating and summing the contribution of all the N terms FijΔBj. Since this would result in (N2) complexity for each iteration of step 2, this algorithm would quickly become unusable even for moderate cell counts. However, using the new sampling techniques described so far, it is possible to compute each term ΔBi′ in
(log N) time, and a full solution in
(N log N) time.
The same techniques can be applied to any other radiosity solver requiring the performance of the gathering of sums of this kind, leading to a whole new family of hierarchical stochastic radiosity solvers.
5. Final Gathering
In the previous sections we proposed several new hierarchical sampling schemes for the evaluation of the coefficient T1·L, giving the projection of reflected lighting on the i-th basis function. For high frequency lighting or sharp glossy reflections, the resolution of the basis functions might be insufficient for direct visualization. However, it's easy to extend all the previously developed techniques to be used in the context of a “final gathering” phase, where the reflected lighting solution is recomputed for each shading point inside a pixel, or interpolated from a set of such shading points.
Let x be the shaded surface point and −ω the incoming viewing direction. We are interested in approximating L(x, ω).
In order to accomplish this, it is sufficient to define a new basis function:
bδ=δxδω (57)
where δx and δ denote the Dirac delta at x and ω, respectively, and evaluate the derived quantity Tδ(x, ω)·L using any of the presently described techniques.
For example, if Technique 1 is used to select S basis functions {jk}k=1, . . . , s, formula (42) becomes:
Finally, L(x, ω) is given by:
L(x,ω)=Tδ(x,ω)·L+L′(x,ω). (59)
6. Photon Mapping
The new finite element basis functions can also be used for a new photon mapping technique. Basically, instead of trying to compute outgoing radiance as the fixed point of an iterative system, one can shoot R photon trajectories from the light sources using any regular photon shooting algorithm based on Monte Carlo or Quasi Monte Carlo sampling, and record, for any surface hit, the outgoing reflected radiance due to the incoming photon projected on all the affected basis functions.
In practice, the technique starts allocating an array of coefficients L(i,j)=0 for any (i,j)=(1,1), (N,M).
Then, during photon shooting, if a photon carrying an amount of energy ΔΦ hits the surface point (x,nx), with incoming direction ω, it is sufficient to find the Voronoi cell i containing the surface hit (using a nearest neighbor query), and update all the coefficients L(i,j) for any j=1, . . . , M by the amount:
where the integral can be estimated by any regular Monte Carlo or Quasi Monte Carlo approximation.
The resulting coefficients can then be used to provide estimates of outgoing reflected radiance at any surface point (x, nx) and in any direction ω using the modified density estimation formula:
where is identifies the s-th Voronoi cell closes to (x, nx) and A=Σs=1S−Ais.
Alternatively, it's possible to use the coefficients L(i,j) as inputs to a final gather pass using Techniques 1, 2, and 3 to computer accurate per-pixel lighting, possibly in conjunction with any image-based or spatial interpolation strategy.
7. Wavelet Direct Transfer Operator for Interactive Relighting
This section presents a framework for computing interactive relighting with global illumination. The key components of the algorithm are the use of a set of meshless wavelet basis functions to represent radiance transfer in a scene and the pre-computation of the full direct transfer operator (DTO) in this space. The DTO is then used during the relighting stage to approximate the effect of the global transfer operator (GTO) at interactive rates.
There is now provided an overview of this technique. Using the notation developed above, the light transport equation can be written using meshless finite elements as:
L=TL′+T2L′+T3L′+ (62)
where T is the N×N finite element transport matrix:
Tij=<Tbj,bi> (63)
Basically, the role of T is to compute the direct lighting due to a given initial light source distribution, and hence it's also called the direct transfer operator, while the equation above states that the global transfer operator can be obtained as the sum of all its powers:
where the i-th term represents the i-th light bounce.
This means that by knowing T, the solution to the rendering equation can be readily computed for any initial emission vector Le, i.e., for any set of light emitters. The main problems are the (N2) computational and memory requirements which would be needed to compute and store each entry of T explicitly.
Here we show how to compute and compress a sparse approximation to T efficiently, and how to computer the product of this approximation with an arbitrary emission vector.
The key insight is that each row Ti represents the direct lighting which would arrive on the i-th finite element if all the other elements had an emission coefficient of 1. Hence, it is possible to compute the entire row Ti using a modified version of Techniques 1 and 2, described above.
Recall that the purpose of these algorithms was to sample a few representative terms of the product Ti·L using a spatial hierarchy on the set of finite elements. If we consider a hypothetical lighting vector L=(1, . . . , 1), it is possible to use the same techniques to sample a few representative terms of the entire row Ti. In particular, Technique 2 can be used to partition the entire set of finite elements into S strata. By using Technique 1, we can then sample a single finite element jk with probability Pjk from each stratum k, such that:
Now, we will assume that the lighting due to all the finite elements in each stratum k is constantly
where, nk is the number of finite elements contained in the stratum. Moreover, we will assume that the indices of all the finite elements contained in each stratum are contiguous and form a continuous range (which is always achievable by numbering the finite elements according to their order of appearance in a depth-first sorting of the finite element hierarchy). With these assumptions, the row Ti will be approximated as a piece-wise constant vector. Now, the wavelet expansion of Ti will be mostly sparse, and hence it will be possible to compute each row Ti sequentially, wavelet encode it, apply standard non-linear compression and storing the compressed coefficients, W Ti. By keeping a limited number S of coefficients the memory requirements for storing T will be proportional to (N×S). Now, this wavelet expansion of T can also be used to quickly approximate products of the kind TL for any lighting vector L: it will be sufficient to compute the wavelet expansion WL and to perform the N dot products:
(TL)i≈WTi·WL. (66)
If WL is compressed keeping only the S most significant coefficients, the above products can be done in (N×S) time.
Finally, this can be used to efficiently evaluate equation (1): it is in fact sufficient to first evaluate TLe, and then use the recursion formula:
TiL′=T(Ti−1L′). (67)
The recursion can be either terminated at a fixed bounce n or when the magnitude of TiLe becomes negligible.
8. General Technique
Box 401: Construct sparse implicit scene representation.
The sparse implicit scene representation is constructed to be independent of geometric encoding and complexity of input scene description. The density of resulting finite elements is proportional to their contribution to the final image. The geometric resolution of a given area of obtained scene representation is proportional to its importance relative to final image.
Monte Carlo or Quasi-Monte Carlo path tracing is used to sample adjoint importance distribution function and shoot importons from a simulated camera into the scene.
For each simulated bounce, there is recorded a particle i defined by 3d position pi, surface normal ni, reflectance factor ρi.
After Box 401, the technique 400 may proceed by combining one or more of the various elements set forth in Boxes 402-406:
Box 402: There is performed at least one of cell sampling, area, and form factor estimates.
Box 403: Upper-bound estimates are computed using either Monte Carlo or Quasi-Monte Carlo sampling.
Box 404: There is performed at least one of (1) importance-based stratification, or (2) re-sampled importance-based stratification.
Box 405: There is performed at least one of (1) hierarchical gathering sum, (2) hierarchical stochastic sampling, or (3) sample warping, using an importance sample and evaluating sums utilizing either a Monte Carlo or Quasi-Monte Carlo quadrature formula.
Box 406: Hierarchical stochastic radiosity solvers are then utilized: a final gathering is performed; and a photon mapping is performed.
As shown in
The flowchart of
9. Digital Processing Environment in Which Invention Can Be Implemented
Systems, apparatuses, computer program products and methods in accordance with the invention are suitable for implementation or execution in a computer graphics system for rendering images for storage or for display on a display element, the computer graphics system comprising a computer, the displaying comprising the display of images on the display element, and wherein the rendering of an image comprises utilizing the computer and/or other elements of the computer graphics system to generate pixel values corresponding to pixels in an image representation.
Systems, apparatuses, computer program products or methods in accordance with the present invention are suitable for implementation or execution in, or in conjunction with, a wide range of commercially available computer graphics systems, including (but not limited to), for example, computer graphics products and systems commercially available from MENTAL IMAGES GmbH of Berlin, Germany. (See, for example, the MENTAL RAY product from MENTAL IMAGES GmbH.) The invention is also suitable for implementation or execution in, or in conjunction with, a wide range of other commercially available computer graphics systems, products, environments, hardware and software that provide rendering functionality. Given the description herein, and the attached drawing figures, one of ordinary skill in the relevant art will understand how the present invention may be so implemented or executed in, or in conjunction with, such commercially available computer graphics systems, products, apparatus or methods.
The following is a discussion, to be read in connection with FIGS. 5 and 6A-6B, of typical, relatively conventional digital processing structures and environments in which the above-described invention may be implemented and practiced.
It will be understood by those skilled in the art that the present invention, as described above, provides methods, systems, devices and computer program products that enable the creation of images and other activities in computer graphics systems, whose output is typically a human-perceptible (or digitally stored and/or transmitted) image or series of images that can comprise, for example, an animated motion picture, computer aided design representation, or other typical computer graphics output. The present invention can thus be implemented as part of the computer software or computer hardware of a computer that forms part of a computer graphics system, along with a display, user interface elements such as a keyboard, tablet and/or mouse, memory, storage, and other conventional computer graphics system components. While conventional components of such kind are well known to those skilled in the art, and thus need not be described in great detail herein, the following overview indicates how the present invention can be implemented in conjunction with such components in a computer graphics system.
More particularly, those skilled in the art will understand that the present invention can be utilized in the generation and synthesis of images, such as for display in a motion picture or other dynamic display. The techniques described herein can be practiced as part of a computer graphics system, in which a pixel value is generated for pixels in an image. The pixel value is representative of a point in a scene as recorded on an image plane of a simulated camera. The underlying computer graphics system can be configured to generate the pixel value for an image using a selected methodology, such as that of the present invention.
The previous detailed description illustrates examples of methods, structures, systems, and computer software products in accordance with these techniques. It will be understood by those skilled in the art that the described methods and systems can be implemented in software, hardware, or a combination of software and hardware, using conventional computer apparatus such as a personal computer (PC) or equivalent device operating in accordance with (or emulating) a conventional operating system such as Microsoft Windows, Linux, or Unix, either in a standalone configuration or across a network. The various processing aspects and means described herein may therefore be implemented in the software and/or hardware elements of a properly configured digital processing device or network of devices. Processing may be performed sequentially or in parallel, and may be implemented using special purpose or re-configurable hardware.
As an example,
The terms “memory”, “storage” and “disk storage devices” can encompass any computer readable medium, such as a computer hard disk, computer floppy disk, computer-readable flash drive, computer-readable RAM or ROM element or any other known means of encoding digital information. The term “applications programs”, “applications”, “programs”, “computer program product” or “computer software product” can encompass any computer program product consisting of computer-readable programs instructions encoded and/or stored on a computer readable medium, whether that medium is fixed or removable, permanent or erasable, or otherwise. As noted, for example, in block 1122 of the schematic block diagram of
Although the computer system 1000 is shown as comprising particular components, such as the keyboard 1002a and mouse 1002b for receiving input information from an operator, and a video display device 1003 for displaying output information to the operator, it will be appreciated that the computer system 1000 may include a variety of components in addition to or instead of those depicted in
In addition, the processor module 1001 can include one or more network ports, generally identified by reference numeral 1005, which are connected to communication links which connect the computer system 1000 in a computer network. The network ports enable the computer system 1000 to transmit information to, and receive information from, other computer systems and other devices in the network. In a typical network organized according to, for example, the client-server paradigm, certain computer systems in the network are designated as servers, which store data and programs (generally, “information”) for processing by the other, client computer systems, thereby to enable the client computer systems to conveniently share the information. A client computer system which needs access to information maintained by a particular server will enable the server to download the information to it over the network. After processing the data, the client computer system may also return the processed data to the server for storage. In addition to computer systems (including the above-described servers and clients), a network may also include, for example, printers and facsimile devices, digital audio or video storage and distribution devices, and the like, which may be shared among the various computer systems connected in the network. The communication links interconnecting the computer systems in the network may, as is conventional, comprise any convenient information-carrying medium, including wires, optical fibers or other media for carrying signals among the computer systems. Computer systems transfer information over the network by means of messages transferred over the communication links, with each message including information and an identifier identifying the device to receive the message.
In addition to the computer system 1000 shown in the drawings, methods, devices or software products in accordance with the present invention can operate on any of a wide range of conventional computing devices and systems, such as those depicted by way of example in
In line with conventional computer software and hardware practice, a software application configured in accordance with the invention can operate within, e.g., a PC 1102 like that shown in
Those skilled in the art will understand that the method aspects of the invention described herein can be executed in hardware elements, such as a Field-Programmable Gate Array (FPGA) or an Application-Specific Integrated Circuit (ASIC) constructed specifically to carry out the processes described herein, using ASIC construction techniques known to ASIC manufacturers. Various forms of ASICs are available from many manufacturers, although currently available ASICs do not provide the functions described in this patent application. Such manufacturers include Intel Corporation and NVIDIA Corporation, both of Santa Clara, Calif. The actual semiconductor elements of a conventional ASIC or equivalent integrated circuit are not part of the present invention, and will not be discussed in detail herein.
Those skilled in the art will also understand that ASICs or other conventional integrated circuit or semiconductor elements can be implemented in such a manner, using the teachings of the present invention as described in greater detail herein, to carry out the methods of the present invention as shown in
Those skilled in the art will also understand that method aspects of the present invention can be carried out within commercially available digital processing systems, such as workstations and personal computers (PCs), operating under the collective command of the workstation or PC's operating system and a computer program product configured in accordance with the present invention. The term “computer program product” can encompass any set of computer-readable programs instructions encoded on a computer readable medium. A computer readable medium can encompass any form of computer readable element, including, but not limited to, a computer hard disk, computer floppy disk, computer-readable flash drive, computer-readable RAM or ROM element, or any other known means of encoding, storing or providing digital information, whether local to or remote from the workstation, PC or other digital processing device or system. Various forms of computer readable elements and media are well known in the computing arts, and their selection is left to the implementer. In each case, the invention is operable to enable a computer system to calculate a pixel value, and the pixel value can be used by hardware elements in the computer system, which can be conventional elements such as graphics cards or display controllers, to generate a display-controlling electronic output. Conventional graphics cards and display controllers are well known in the computing arts are not necessarily part of the present invention, and their selection can be left to the implementer.
While the foregoing description includes details which will enable those skilled in the art to practice the invention, it should be recognized that the description is illustrative in nature and that many modifications and variations thereof will be apparent to those skilled in the art having the benefit of these teachings. It is accordingly intended that the invention herein be defined solely by the claims appended hereto and that the claims be interpreted as broadly as permitted by the prior art.
This application for patent claims the priority benefit of U.S. Provisional Patent Application Ser. No. 60/870,044, filed on Dec. 14, 2006.
Number | Name | Date | Kind |
---|---|---|---|
4973111 | Haacke | Nov 1990 | A |
6028606 | Kolb | Feb 2000 | A |
6529193 | Herken | Mar 2003 | B1 |
6529197 | Ballard et al. | Mar 2003 | B1 |
6911976 | Abramov | Jun 2005 | B2 |
7006110 | Crisu | Feb 2006 | B2 |
7085435 | Takiguchi | Aug 2006 | B2 |
20020126129 | Snyder | Sep 2002 | A1 |
20030063082 | Abramov | Apr 2003 | A1 |
20040125103 | Kaufman | Jul 2004 | A1 |
20050264564 | Keller | Dec 2005 | A1 |
20050264565 | Keller | Dec 2005 | A1 |
20050264568 | Keller | Dec 2005 | A1 |
20050275652 | Keller | Dec 2005 | A1 |
20050275660 | Keller | Dec 2005 | A1 |
20050275663 | Kokojima | Dec 2005 | A1 |
20050278406 | Keller | Dec 2005 | A1 |
20060005193 | Illowsky | Jan 2006 | A1 |
20060062487 | Ouchi | Mar 2006 | A1 |
20060188175 | Takiguchi | Aug 2006 | A1 |
20070046686 | Keller | Mar 2007 | A1 |
20070109320 | Skibak | May 2007 | A1 |
20070127101 | Oldroyd | Jun 2007 | A1 |
20070271322 | Keller | Nov 2007 | A1 |
Number | Date | Country |
---|---|---|
02 03326 | Jan 2002 | WO |
03 098467 | Nov 2003 | WO |
Number | Date | Country | |
---|---|---|---|
20080150938 A1 | Jun 2008 | US |
Number | Date | Country | |
---|---|---|---|
60870044 | Dec 2006 | US |