Attention

You are reading an old version (0.19.2) of the documentation. For the latest version, see https://nvlabs.github.io/sionna/.

Primer on Electromagnetics

This section provides useful background for the general understanding of ray tracing for wireless propagation modelling. In particular, our goal is to provide a concise definition of a channel impulse response between a transmitting and receiving antenna, as done in (Ch. 2 & 3) [Wiesbeck]. The notations and definitions will be used in the API documentation of Sionna’s Ray Tracing module.

Coordinate system, rotations, and vector fields

We consider a global coordinate system (GCS) with Cartesian standard basis x^, y^, z^. The spherical unit vectors are defined as

(1)r^(θ,φ)=sin(θ)cos(φ)x^+sin(θ)sin(φ)y^+cos(θ)z^θ^(θ,φ)=cos(θ)cos(φ)x^+cos(θ)sin(φ)y^sin(θ)z^φ^(θ,φ)=sin(φ)x^+cos(φ)y^.

For an arbitrary unit norm vector v^=(x,y,z), the zenith and azimuth angles θ and φ can be computed as

(2)θ=cos1(z)φ=atan2(y,x)

where atan2(y,x) is the two-argument inverse tangent function [atan2]. As any vector uniquely determines θ and φ, we sometimes also write θ^(v^) and φ^(v^) instead of θ^(θ,φ) and φ^(θ,φ).

A 3D rotation with yaw, pitch, and roll angles α, β, and γ, respectively, is expressed by the matrix

(3)R(α,β,γ)=Rz(α)Ry(β)Rx(γ)

where Rz(α), Ry(β), and Rx(γ) are rotation matrices around the z, y, and x axes, respectively, which are defined as

Rz(α)=(cos(α)sin(α)0sin(α)cos(α)0001)Ry(β)=(cos(β)0sin(β)010sin(β)0cos(β))Rx(γ)=(1000cos(γ)sin(γ)0sin(γ)cos(γ)).

A closed-form expression for R(α,β,γ) can be found in (7.1-4) [TR38901]. The reverse rotation is simply defined by R1(α,β,γ)=RT(α,β,γ). A vector x defined in a first coordinate system is represented in a second coordinate system rotated by R(α,β,γ) with respect to the first one as x=RT(α,β,γ)x. If a point in the first coordinate system has spherical angles (θ,φ), the corresponding angles (θ,φ) in the second coordinate system can be found to be

(4)θ=cos1(z^TRT(α,β,γ)r^(θ,φ))φ=arg((x^+jy^)TRT(α,β,γ)r^(θ,φ)).

For a vector field F(θ,φ) expressed in local spherical coordinates

F(θ,φ)=Fθ(θ,φ)θ^(θ,φ)+Fφ(θ,φ)φ^(θ,φ)

that are rotated by R=R(α,β,γ) with respect to the GCS, the spherical field components in the GCS can be expressed as

(5)[Fθ(θ,φ)Fφ(θ,φ)]=[θ^(θ,φ)TRθ^(θ,φ)θ^(θ,φ)TRφ^(θ,φ)φ^(θ,φ)TRθ^(θ,φ)φ^(θ,φ)TRφ^(θ,φ)][Fθ(θ,φ)Fφ(θ,φ)]

so that

F(θ,φ)=Fθ(θ,φ)θ^(θ,φ)+Fφ(θ,φ)φ^(θ,φ).

It sometimes also useful to find the rotation matrix that maps a unit vector a^ to b^. This can be achieved with the help of Rodrigues’ rotation formula [Wikipedia_Rodrigues] which defines the matrix

(6)R(a^,b^)=I+sin(θ)K+(1cos(θ))K2

where

K=[0k^zk^yk^z0k^xk^yk^x0]k^=a^×b^a^×b^θ=a^Tb^

such that R(a^,b^)a^=b^.

Planar Time-Harmonic Waves

A time-harmonic planar electric wave E(x,t)C3 travelling in a homogeneous medium with wave vector kC3 can be described at position xR3 and time t as

E(x,t)=E0ej(ωtkHx)=E(x)ejωt

where E0C3 is the field phasor. The wave vector can be decomposed as k=kk^, where k^ is a unit norm vector, k=ωεμ is the wave number, and ω=2πf is the angular frequency. The permittivity ε and permeability μ are defined as

(7)ε=ηε0
(8)μ=μrμ0

where η and ε0 are the complex relative and vacuum permittivities, μr and μ0 are the relative and vacuum permeabilities, and σ is the conductivity. The complex relative permittivity η is given as

(9)η=εrjσε0ω

where εr is the real relative permittivity of a non-conducting dielectric.

With these definitions, the speed of light is given as (Eq. 4-28d) [Balanis]

c=1ε0εrμ{12(1+(σωε0εr)2+1)}12

where the factor in curly brackets vanishes for non-conducting materials. The speed of light in vacuum is denoted c0=1ε0μ0 and the vacuum wave number k0=ωc0. In conducting materials, the wave number is complex which translates to propagation losses.

The associated magnetic field H(x,t)C3 is

H(x,t)=k^×E(x,t)Z=H(x)ejωt

where Z=μ/ε is the wave impedance. The vacuum impedance is denoted by Z0=μ0/ε0376.73Ω.

The time-averaged Poynting vector is defined as

S(x)=12{E(x)×H(x)}=12{1Z}E(x)2k^

which describes the directional energy flux (W/m²), i.e., energy transfer per unit area per unit time.

Note that the actual electromagnetic waves are the real parts of E(x,t) and H(x,t).

Far Field of a Transmitting Antenna

We assume that the electric far field of an antenna in free space can be described by a spherical wave originating from the center of the antenna:

E(r,θ,φ,t)=E(r,θ,φ)ejωt=E0(θ,φ)ejk0rrejωt

where E0(θ,φ) is the electric field phasor, r is the distance (or radius), θ the zenith angle, and φ the azimuth angle. In contrast to a planar wave, the field strength decays as 1/r.

The complex antenna field pattern F(θ,φ) is defined as

(10)F(θ,φ)=E0(θ,φ)maxθ,φE0(θ,φ).

The time-averaged Poynting vector for such a spherical wave is

(11)S(r,θ,φ)=12Z0E(r,θ,φ)2r^

where r^ is the radial unit vector. It simplifies for an ideal isotropic antenna with input power PT to

Siso(r,θ,φ)=PT4πr2r^.

The antenna gain G is the ratio of the maximum radiation power density of the antenna in radial direction and that of an ideal isotropic radiating antenna:

(12)G=maxθ,φS(r,θ,φ)Siso(r,θ,φ)=2πZ0PTmaxθ,φE0(θ,φ)2.

One can similarly define a gain with directional dependency by ignoring the computation of the maximum the last equation:

(13)G(θ,φ)=2πZ0PTE0(θ,φ)2=GF(θ,φ)2.

If one uses in the last equation the radiated power P=ηradPT, where ηrad is the radiation efficiency, instead of the input power PT, one obtains the directivity D(θ,φ). Both are related through G(θ,φ)=ηradD(θ,φ).

Antenna pattern

Since F(θ,φ) contains no information about the maximum gain G and G(θ,φ) does not carry any phase information, we define the antenna pattern C(θ,φ) as

(14)C(θ,φ)=GF(θ,φ)

such that G(θ,φ)=C(θ,φ)2.

Using the spherical unit vectors θ^R3 and φ^R3, we can rewrite C(θ,φ) as

C(θ,φ)=Cθ(θ,φ)θ^+Cφ(θ,φ)φ^

where Cθ(θ,φ)C and Cφ(θ,φ)C are the zenith pattern and azimuth pattern, respectively.

Combining (10) and (12), we can obtain the following expression of the electric far field

(15)ET(r,θT,φT)=PTGTZ02πejk0rrFT(θT,φT)

where we have added the subscript T to all quantities that are specific to the transmitting antenna.

The input power PT of an antenna with (conjugate matched) impedance ZT, fed by a voltage source with complex amplitude VT, is given by (see, e.g., [Wikipedia])

(16)PT=|VT|28{ZT}.

Normalization of antenna patterns

The radiated power ηradPT of an antenna can be obtained by integrating the Poynting vector over the surface of a closed sphere of radius r around the antenna:

ηradPT=02π0πS(r,θ,φ)Tr^r2sin(θ)dθdφ=02π0π12Z0E(r,θ,φ)2r2sin(θ)dθdφ=PT4π02π0πG(θ,φ)sin(θ)dθdφ.

We can see from the last equation that the directional gain of any antenna must satisfy

02π0πG(θ,φ)sin(θ)dθdφ=4πηrad.

Modelling of a Receiving Antenna

Although the transmitting antenna radiates a spherical wave ET(r,θT,φT), we assume that the receiving antenna observes a planar incoming wave ER that arrives from the angles θR and φR which are defined in the local spherical coordinates of the receiving antenna. The Poynting vector of the incoming wave SR is hence (11)

(17)SR=12Z0ER2r^(θR,φR)

where r^(θR,φR) is the radial unit vector in the spherical coordinate system of the receiver.

The aperture or effective area AR of an antenna with gain GR is defined as the ratio of the available received power PR at the output of the antenna and the absolute value of the Poynting vector, i.e., the power density:

(18)AR=PRSR=GRλ24π

where λ24π is the aperture of an isotropic antenna. In the definition above, it is assumed that the antenna is ideally directed towards and polarization matched to the incoming wave. For an arbitrary orientation of the antenna (but still assuming polarization matching), we can define a direction dependent effective area

(19)AR(θR,φR)=GR(θR,φR)λ24π.

The available received power at the output of the antenna can be expressed as

(20)PR=|VR|28{ZR}

where ZR is the impedance of the receiving antenna and VR the open circuit voltage.

We can now combine (20), (19), and (18) to obtain the following expression for the absolute value of the voltage |VR| assuming matched polarization:

|VR|=PR8{ZR}=λ24πGR(θR,φR)8{ZR}2Z0ER2=λ24πGR4{ZR}Z0FR(θR,φR)ER.

By extension of the previous equation, we can obtain an expression for VR which is valid for arbitrary polarizations of the incoming wave and the receiving antenna:

(21)VR=λ24πGR4{ZR}Z0FR(θR,φR)HER.

Example: Recovering Friis equation

In the case of free space propagation, we have ER=ET(r,θT,φT). Combining (21), (20), and (15), we obtain the following expression for the received power:

PR=(λ4πr)2GRGTPT|FR(θR,φR)HFT(θT,φT)|2.

It is important that FR and FT are expressed in the same coordinate system for the last equation to make sense. For perfect orientation and polarization matching, we can recover the well-known Friis transmission equation:

PRPT=(λ4πr)2GRGT.

General Propagation Path

A single propagation path consists of a cascade of multiple scattering processes, where a scattering process can be anything that prevents the wave from propagating as in free space. This includes reflection, refraction, diffraction, and diffuse scattering. For each scattering process, one needs to compute a relationship between the incoming field at the scatter center and the created far field at the next scatter center or the receiving antenna. We can represent this cascade of scattering processes by a single matrix T~ that describes the transformation that the radiated field ET(r,θT,φT) undergoes until it reaches the receiving antenna:

(22)ER=PTGTZ02πT~FT(θT,φT).

Note that we have obtained this expression by replacing the free space propagation term ejk0rr in (15) by the matrix T~. This requires that all quantities are expressed in the same coordinate system which is also assumed in the following expressions. Further, it is assumed that the matrix T~ includes the necessary coordinate transformations. In some cases, e.g., for diffuse scattering (see (38) in Scattering), the matrix T~ depends on the incoming field and is not a linear transformation.

Plugging (22) into (21), we can obtain a general expression for the received voltage of a propagation path:

VR=(λ4π)2GRGTPT8{ZR}FR(θR,φR)HT~FT(θT,φT).

If the electromagnetic wave arrives at the receiving antenna over N propagation paths, we can simply add the received voltages from all paths to obtain

(23)VR=(λ4π)2GRGTPT8{ZR}n=1NFR(θR,i,φR,i)HT~iFT(θT,i,φT,i)=(λ4π)2PT8{ZR}n=1NCR(θR,i,φR,i)HT~iCT(θT,i,φT,i)

where all path-dependent quantities carry the subscript i. Note that the matrices T~i also ensure appropriate scaling so that the total received power can never be larger than the transmit power.

Frequency & Impulse Response

The channel frequency response H(f) at frequency f=cλ is defined as the ratio between the received voltage and the voltage at the input to the transmitting antenna:

(24)H(f)=VRVT=VR|VT|

where it is assumed that the input voltage has zero phase.

It is useful to separate phase shifts due to wave propagation from the transfer matrices T~i. If we denote by ri the total length of path i with average propagation speed ci, the path delay is τi=ri/ci. We can now define the new transfer matrix

(25)Ti=T~iej2πfτi.

Using (16) and (25) in (23) while assuming equal real parts of both antenna impedances, i.e., {ZT}={ZR} (which is typically the case), we obtain the final expression for the channel frequency response:

(26)H(f)=i=1Nλ4πCR(θR,i,φR,i)HTiCT(θT,i,φT,i)aiej2πfτi

Taking the inverse Fourier transform, we finally obtain the channel impulse response

(27)h(τ)=H(f)ej2πfτdf=i=1Naiδ(ττi)

The baseband equivalent channel impulse reponse is then defined as (Eq. 2.28) [Tse]:

(28)hb(τ)=i=1Naiej2πfτiaibδ(ττi).

Reflection and Refraction

When a plane wave hits a plane interface which separates two materials, e.g., air and concrete, a part of the wave gets reflected and the other transmitted (or refracted), i.e., it propagates into the other material. We assume in the following description that both materials are uniform non-magnetic dielectrics, i.e., μr=1, and follow the definitions as in [ITURP20402]. The incoming wave phasor Ei is expressed by two arbitrary orthogonal polarization components, i.e.,

Ei=Ei,se^i,s+Ei,pe^i,p

which are both orthogonal to the incident wave vector, i.e., e^i,sTe^i,p=e^i,sTk^i=e^i,pTk^i=0.

_images/reflection.svg

Fig. 1 Reflection and refraction of a plane wave at a plane interface between two materials.

Fig. 1 shows reflection and refraction of the incoming wave at the plane interface between two materials with relative permittivities η1 and η2. The coordinate system is chosen such that the wave vectors of the incoming, reflected, and transmitted waves lie within the plane of incidence, which is chosen to be the x-z plane. The normal vector of the interface n^ is pointing toward the negative z axis. The incoming wave is must be represented in a different basis, i.e., in the form two different orthogonal polarization components Ei, and Ei,, i.e.,

Ei=Ei,e^i,+Ei,e^i,

where the former is orthogonal to the plane of incidence and called transverse electric (TE) polarization (left), and the latter is parallel to the plane of incidence and called transverse magnetic (TM) polarization (right). We adopt in the following the convention that all transverse components are coming out of the figure (indicated by the symbol). One can easily verify that the following relationships must hold:

(29)e^i,=k^i×n^k^i×n^e^i,=e^i,×k^i
[Ei,Ei,]=[e^i,Te^i,se^i,Te^i,pe^i,Te^i,se^i,Te^i,p][Ei,sEi,p]=W(e^i,,e^i,,e^i,s,e^i,p)[Ei,sEi,p]

where we have defined the following matrix-valued function

(30)W(a^,b^,q^,r^)=[a^Tq^a^Tr^b^Tq^b^Tr^].

While the angles of incidence and reflection are both equal to θ1, the angle of the refracted wave θ2 is given by Snell’s law:

sin(θ2)=η1η2sin(θ1)

or, equivalently,

cos(θ2)=1η1η2sin2(θ1).

The reflected and transmitted wave phasors Er and Et are similarly represented as

Er=Er,e^r,+Er,e^r,Et=Et,e^t,+Et,e^t,

where

(31)e^r,=e^i,e^r,=e^r,×k^re^r,×k^re^t,=e^i,e^t,=e^t,×k^te^t,×k^t

and

(32)k^r=k^i2(k^iTn^)n^k^t=η1η2k^i+(η1η2cos(θ1)cos(θ2))n^.

The Fresnel equations provide relationships between the incident, reflected, and refracted field components for |η1/η2|sin(θ1)<1:

(33)r=Er,Ei,=η1cos(θ1)η2cos(θ2)η1cos(θ1)+η2cos(θ2)r=Er,Ei,=η2cos(θ1)η1cos(θ2)η2cos(θ1)+η1cos(θ2)t=Et,Et,=2η1cos(θ1)η1cos(θ1)+η2cos(θ2)t=Et,Et,=2η1cos(θ1)η2cos(θ1)+η1cos(θ2).

If |η1/η2|sin(θ1)1, we have r=r=1 and t=t=0, i.e., total reflection.

For the case of an incident wave in vacuum, i.e., η1=1, the Fresnel equations (33) simplify to

(34)r=cos(θ1)η2sin2(θ1)cos(θ1)+η2sin2(θ1)r=η2cos(θ1)η2sin2(θ1)η2cos(θ1)+η2sin2(θ1)t=2cos(θ1)cos(θ1)+η2sin2(θ1)t=2η2cos(θ1)η2cos(θ1)+η2sin2(θ1).

Putting everything together, we obtain the following relationships between incident, reflected, and transmitted waves:

[Er,Er,]=[r00r]W(e^i,,e^i,,e^i,s,e^i,p)[Ei,sEi,p][Et,Et,]=[t00t]W(e^i,,e^i,,e^i,s,e^i,p)[Ei,sEi,p].

Diffraction

While modern geometrical optics (GO) [Kline], [Luneberg] can accurately describe phase and polarization properties of electromagnetic fields undergoing reflection and refraction (transmission) as described above, they fail to account for the phenomenon of diffraction, e.g., bending of waves around corners. This leads to the undesired and physically incorrect effect that the field abruptly falls to zero at geometrical shadow boundaries (for incident and reflected fields).

Joseph Keller presented in [Keller62] a method which allowed the incorporation of diffraction into GO which is known as the geometrical theory of diffraction (GTD). He introduced the notion of diffracted rays that follow the law of edge diffraction, i.e., the diffracted and incident rays make the same angle with the edge at the point of diffraction and lie on opposite sides of the plane normal to the edge. The GTD suffers, however from several shortcomings, most importantly the fact that the diffracted field is infinite at shadow boundaries.

The uniform theory of diffraction (UTD) [Kouyoumjian74] alleviates this problem and provides solutions that are uniformly valid, even at shadow boundaries. For a great introduction to the UTD, we refer to [McNamara90]. While [Kouyoumjian74] deals with diffraction at edges of perfectly conducting surfaces, it was heuristically extended to finitely conducting wedges in [Luebbers84]. This solution, which is also recomended by the ITU [ITURP52615], is implemented in Sionna. However, both [Luebbers84] and [ITURP52615] only deal with two-dimensional scenes where source and observation lie in the same plane, orthogonal to the edge. We will provide below the three-dimensional version of [Luebbers84], following the defintitions of (Ch. 6) [McNamara90]. A similar result can be found, e.g., in (Eq. 6-29—6-39) [METIS].

_images/kellers_cone.svg

Fig. 2 Incident and diffracted rays for an infinitely long wedge in an edge-fixed coordinate system.

We consider an infinitely long wedge with unit norm edge vector e^, as shown in Fig. 2. An incident ray of a spherical wave with field phasor Ei(S) at point S propagates in the direction s^ and is diffracted at point Qd on the edge. The diffracted ray of interest (there are infinitely many on Keller’s cone) propagates in the direction s^ towards the point of observation S. We denote by s=SQd and s=QdS the lengths of the incident and diffracted path segments, respectively. By the law of edge diffraction, the angles β0 and β0 between the edge and the incident and diffracted rays, respectively, satisfy:

cos(β0)=|s^Te^|=|s^Te^|=cos(β0).

To be able to express the diffraction coefficients as a 2x2 matrix—similar to what is done for reflection and refraction—the incident field must be resolved into two components Ei,ϕ and Ei,β0, the former orthogonal and the latter parallel to the edge-fixed plane of incidence, i.e., the plane containing e^ and s^. The diffracted field is then represented by two components Ed,ϕ and Ed,β0 that are respectively orthogonal and parallel to the edge-fixed plane of diffraction, i.e., the plane containing e^ and s^. The corresponding component unit vectors are defined as

ϕ^=s^×e^s^×e^β^0=ϕ^×s^ϕ^=s^×e^s^×e^β^0=ϕ^×s^.

Fig. 3 below shows the top view on the wedge that we need for some additional definitions.

_images/diffraction.svg

Fig. 3 Top view on the wedge with edge vector pointing upwards.

The wedge has two faces called 0-face and n-face, respectively, with surface normal vectors n^0 and n^n. The exterior wedge angle is nπ, with 1n2. Note that the surfaces are chosen such that e^=n^0×n^n. For n=2, the wedge reduces to a screen and the choice of the 0-face and n-face is arbitrary as they point in opposite directions.

The incident and diffracted rays have angles ϕ and ϕ measured with respect to the 0-face in the plane perpendicular to the edge. They can be computed as follows:

ϕ=π[πcos1(s^tTt^0)]sgn(s^tTn^0)ϕ=π[πcos1(s^tTt^0)]sgn(s^tTn^0)

where

t^0=n^0×e^s^t=s^(s^Te^)e^s^(s^Te^)e^s^t=s^(s^Te^)e^s^(s^Te^)e^

are the unit vector tangential to the 0-face, as well as the unit vectors pointing in the directions of s^ and s^, projected on the plane perpendicular to the edge, respectively. The function sgn(x) is defined in this context as

sgn(x)={1,x01,x<0.

With these definitions, the diffracted field at point S can be computed from the incoming field at point S as follows:

[Ed,ϕEd,β0](S)=((D1+D2)ID3RnD4R0)[Ei,ϕEi,β0](S)1ss(s+s)ejk(s+s)

where k=2π/λ is the wave number and the matrices Rν,ν[0,n], are given as

(35)Rν=W(ϕ^,β^0,e^r,,ν,e^r,,ν)[r(θr,ν,ην)00r(θr,ν,ηnu)]W(e^i,,ν,e^i,,ν,ϕ^,β^0)

with W() as defined in (30), where r(θr,ν,ην) and r(θr,ν,ην) are the Fresnel reflection coefficents from (34), evaluated for the complex relative permittivities ην and angles θr,ν with cosines

(36)cos(θr,0)=|sin(ϕ)|cos(θr,n)=|sin(nπϕ)|.

and where

e^i,,ν=s^×n^νs^×n^νe^i,,ν=e^i,,ν×s^e^r,,ν=e^i,,νe^r,,ν=e^i,,ν×s^

as already defined in (29) and (31), but made explicit here for the case of diffraction. The matrices Rν simply describe the reflected field from both surfaces in the basis used for the description of the diffraction process. Note that the absolute value is used in (36) to account for virtual reflections from shadowed surfaces, see the discussion in (p.185) [McNamara90]. The diffraction coefficients D1,,D4 are computed as

D1=ejπ42n2πksin(β0)cot(π+(ϕϕ)2n)F(kLa+(ϕϕ))D2=ejπ42n2πksin(β0)cot(π(ϕϕ)2n)F(kLa(ϕϕ))D3=ejπ42n2πksin(β0)cot(π+(ϕ+ϕ)2n)F(kLa+(ϕ+ϕ))D4=ejπ42n2πksin(β0)cot(π(ϕ+ϕ)2n)F(kLa(ϕ+ϕ))

where

L=sss+ssin2(β0)a±(β)=2cos2(2nπN±β2)N±=round(β±π2nπ)F(x)=2jxejxxejt2dt

and round() is the function that rounds to the closest integer. The function F(x) can be expressed with the help of the standard Fresnel integrals [Fresnel]

S(x)=0xsin(πt2/2)dtC(x)=0xcos(πt2/2)dt

as

F(x)=πx2ejx[1+j2(S(2x/π)+jC(2x/π))].

Scattering

When an electromagnetic wave impinges on a surface, one part of the energy gets reflected while the other part gets refracted, i.e., it propagates into the surface. We distinguish between two types of reflection, specular and diffuse. The former type is discussed in Reflection and Refraction and we will focus now on the latter type which is also called diffuse scattering. When a rays hits a diffuse reflection surface, it is not reflected into a single (specular) direction but rather scattered toward many different directions. Since most surfaces give both specular and diffuse reflections, we denote by S2 the fraction of the reflected energy that is diffusely scattered, where S[0,1] is the so-called scattering coefficient [Degli-Esposti07]. Similarly, R2 is the specularly reflected fraction of the reflected energy, where R[0,1] is the reflection reduction factor. The following relationship between R and S holds:

(37)R=1S2.

Whenever a material has a scattering coefficient S>0, the Fresnel reflection coefficents in (33) must be multiplied by R. These reduced coefficients must then be also used in the compuation of the diffraction coefficients (35).

_images/scattering.svg

Fig. 4 Diffuse and specular reflection of an incoming wave.

Let us consider an incoming locally planar linearly polarized wave with field phasor Ei(q) at the scattering point q on the surface, as shown in Fig. 4. We focus on the scattered field of and infinitesimally small surface element dA in the direction k^s. Note that the surface normal n^ has an arbitrary orientation with respect to the global coordinate system, whose (x,y,z) axes are shown in green dotted lines. The incoming field phasor can be represented by two arbitrary orthogonal polarization components (both orthogonal to the incoming wave vector k^i):

Ei=Ei,se^i,s+Ei,pe^i,p=Ei,e^i,+Ei,e^i,=Ei,pole^i,pol+Ei,xpole^i,xpol

where me have omitted the dependence of the field strength on the position q for brevity. The second representation via (Ei,,Ei,) is used for the computation of the specularly reflected field as explained in Reflection and refraction. The third representation via (Ei,pol,Ei,xpol) will be used to express the scattered field, where

e^i,pol=={Ei}{Ei}={Ei,s}{Ei}e^i,s+{Ei,p}{Ei}e^i,pe^i,xpol=e^pol×k^i

such that |Ei,pol|=Ei and Ei,xpol=0. That means that e^i,pol points toward the polarization direction which carries all of the energy.

According to (Eq. 9) [Degli-Esposti11], the diffusely scattered field Es(r) at the observation point r can be modeled as Es(r)=Es,θθ^(k^s)+Es,φφ^(k^s), where θ^,φ^ are defined in (1) and the orthogonal field components are computed as

(38)[Es,θEs,φ](r)=Es(q)rqW(θ^(k^i),φ^(k^i),e^i,pol,e^i,xpol)[1Kxejχ1Kxejχ2]

where W() as defined in (30), χ1,χ2[0,2π] are independent random phase shifts, and the quantity Kx[0,1] is defined by the scattering cross-polarization discrimination

(39)XPDs=10log10(|Es,pol|2|Es,xpol|2)=10log10(1KxKx).

This quantity determines how much energy gets transfered from e^i,pol into the orthogonal polarization direction e^i,xpol through the scattering process. The matrix W is used to represent the scattered electric field in the vertical (θ^) and horizontal (φ^) polarization components according to the incoming ray direction k^i. It is then assumed that the same polarization is kept for the outgoing ray in the k^s direction.

The squared amplitude of the diffusely scattered field in (38) can be expressed as (Eq. 8) [Degli-Esposti07]:

Es(q))2=Ei(q)2cos(θi)dAincoming power(SΓ)2fraction of diffusely reflected powerfs(k^i,k^s,n^)scattering pattern

where Γ2 is the percentage of the incoming power that is reflected (specularly and diffuse), which can be computed as

Γ=|rEi,|2+|rEi,|2Ei(q)

where r,r are defined in (33), dA is the size of the small area element on the reflecting surface under consideration, and fs(k^i,k^s,n^) is the scattering pattern, which has similarities with the bidirectional reflectance distribution function (BRDF) in computer graphics (Ch. 5.6.1) [Pharr]. The scattering pattern must be normalized to satisfy the condition

0π/202πfs(k^i,k^s,n^)sin(θs)dϕsdθs=1

which ensures the power balance between the incoming, reflected, and refracted fields.

Example scattering patterns

The authors of [Degli-Esposti07] derived several simple scattering patterns that were shown to achieve good agreement with measurements when correctly parametrized.

Lambertian Model (LambertianPattern): This model describes a perfectly diffuse scattering surface whose scattering radiation lobe has its maximum in the direction of the surface normal:

(40)fsLambert(k^i,k^s,n^)=n^Tk^sπ=cos(θs)π

Directive Model (DirectivePattern): This model assumes that the scattered field is concentrated around the direction of the specular reflection k^r (defined in (32)). The width of the scattering lobe can be controlled via the integer parameter αR=1,2,:

(41)fsdirective(k^i,k^s,n^)=FαR(θi)1(1+k^rTk^s2)αR
Fα(θi)=12αk=0α(αk)Ik,θi=cos1(k^iTn^)
Ik=2πk+1{1,k evencos(θi)w=0(k1)/2(2ww)sin2w(θi)22w,k odd

Backscattering Lobe Model (BackscatteringPattern): This model adds a scattering lobe to the directive model described above which points toward the direction from which the incident wave arrives (i.e., k^i). The width of this lobe is controlled by the parameter αI=1,2,. The parameter Λ[0,1] determines the distribution of energy between both lobes. For Λ=1, this models reduces to the directive model.

(42)fsbs(k^i,k^s,n^)=FαR,αI(θi)1[Λ(1+k^rTk^s2)αR+(1Λ)(1k^iTk^s2)αI]
Fα,β(θi)1=ΛFα(θi)+(1Λ)Fβ(θi)

Reconfigurable Intelligent Surfaces (RIS)

Metasurfaces can manipulate electromagnetic waves in a way that traditional materials cannot. For example, they can be used to create anomalous reflections, focalization, as well as polarization changes. A reconfigurable intelligent surface (RIS) is a special type of metasurface that can be dynamically controlled to achieve favorable propagation conditions in a specific enviroment. While many different ways to model RIS have been proposed in the literature [Di-Renzo20], we adopt here the ones described in [Degli-Esposti22] and [Vitucci24]. The former will be used for the computation of channel impulse responses (CIRs) (see compute_paths()) while the latter will serve for the computation of coverage maps (see coverage_map()).

We consider only lossless RIS, i.e., there is no power dissipation. For waves incident on the front side of an RIS, only the reradiated modes but neither specular nor diffuse reflections are created. For waves incident on the back side, an RIS behaves like a perfect absorber. For coverage maps, diffraction around the RIS’ edges is ignored.

An RIS consists of a regular grid of unit cells which impose a spatial modulation, i.e., phase and amplitude changes, on an incident wave. This leads in turn to the creation of M1 reradiated modes. Let us denote by (y,z) a generic point on the RIS, and by χm(y,z) and Am(y,z) the phase and amplitude modulation coefficients of the mth reradiation mode, respectively. We assume that the RIS’ normal n^ points toward the positive x-axis.

The spatial modulation coefficient Γ(y,z) is then given as (Eq.12) [Degli-Esposti22]

(43)Γ(y,z)=m=1MpmAm(y,z)ejχm(y,z)

where pm is the reradiation intensity coefficient of the mth mode. For power conservation reasons, we need to impose that m=1Mpm=1 and that the normalized surface integral of |Am(y,z)|2 across the RIS equals one for all m.

_images/ris.svg

Fig. 5 Incident and reradiated field from a reconfigurable intelligent surface (RIS).

Consider now an RIS as shown in Fig. 5 with an incident electro-magnetic wave with field phasor Ei(S) at point SR3, where Ei,θ(S) and Ei,φ(S) denote the vertical and horizontal field components, respectively. The reradiated field from the RIS at point S is computed as (Eq.30) [Degli-Esposti22]:

(44)Er(S)=u=1NYv=1NZΓ(yu,zv)3λ16π(1+cosθi(yu,zv))(1+cosθr(yu,zv))×ejk0(si(yu,zv)+sr(yu,zv))si(yu,zv)sr(yu,zv)(Ei,θ(S)θ^(k^r(yu,zv))+Ei,φ(S)φ^(k^r(yu,zv)))

where NY and NZ are the number of columns and rows of the regular grid of unit cells with coordinates (yu,zv) for 1uNY and 1vNZ, k^i(yu,zv) and k^r(yu,zv) are the directions of the incident and reradiated waves at position (yu,zv), θi(yu,zv) and θr(yu,zv) are the angles between the RIS’s normal and the incident and reradiated directions, respectively, and si(yu,zv) and sr(yu,zv) are the distances between the unit cell (yu,zv) and S,S, respectively. With a slight abuse of notation, we denote by θ^(k^) and φ^(k^) the spherical unit vectors (1) for angles defined by k^ according to (2). One can observe from the last equation that the RIS does not impact the polarization. Note that (44) is only used in compute_paths() for the computation of the channel impulse response.

_images/ris_ray.svg

Fig. 6 An RIS anomalously reflects an incoming ray due to its phase gradient χm.

For the computation of coverage maps, the ray-based model from [Vitucci24] is used. Fig. 6 shows how an RIS anomalously reflects an incident ray, intersecting the RIS at point qR3 in the y-z plane. The incident ray with propagation direction k^i, representing a locally-plane wavefront, acquires an incident phase gradient χi on the RIS’ surface which can be computed as (Eq.9) [Vitucci24]

(45)χi=k0(In^n^T)k^i.

Each of the RIS’ reradiation modes gives rise to an additional phase gradient χm at the point of intersection, which results in the total phase gradient (Eq.11) [Vitucci24]

(46)χ(q)=χi+χm(q).

It is this total phase gradient that determines the direction of the reflected ray k^r for reradiation mode m which can be computed as (Eq.13) [Vitucci24]

(47)k^r=χ(q)k0+1χ(q)k02n^.

From the last equation, it becomes clear that the phase profile and its derivative must be computed at arbitrary positions on the RIS’ surface. However, in Sionna RT, phase and amplitude profiles are only configured as discrete values on a regular grid with λ/2 spacing. For this reason, the discrete profiles are interpolated using a ProfileInterpolator, such as the LagrangeProfileInterpolator. It is important to keep in mind that the phase profile typically varies on the wavelength-scale across the RIS, and the amplitude profile at an even larger scale. Both profiles must be carefully chosen to represent a physically realistic device (see, e.g., the discussion after (Eq.16) [Vitucci24] ).

_images/asticmatic_ray_tube.svg

Fig. 7 Infinitely narrow asticmatic ray tube.

A side-effect of the anomalous ray reflection is that the reflected wavefront generally has a different shape as that of the incoming wavefront. The shape of an astigmatic wave (or ray tube), as shown in Fig. 7, is represented by the curvature matrix Q(s)R3×3 along its propagation path (see, e.g., (Appenix I) [Kouyoumjian74] ), which can be written as

(48)Q(s)=1ρ1+sx^1x^1T+1ρ2+sx^2x^2T

where ρ1 and ρ2 are the principal radii of curvature, and x^1 and x^2 are the corresponding principal directions; both orthogonal to the propagation direction s, where s denotes a point on the ray with respect to a reference point s=0.

For an incoming ray with curvature matrix Qi(q) at the intersection point, the curvature matrix Qr(q) of the outgoing ray can be computed as (Eq.22) [Vitucci24]

(49)Qr(q)=LT(Qi(q)1k0Hχm(q))L

where Hχm(q)R3×3 is the Hessian matrix of the phase profile χm at the intersection point and

(50)L=Ik^rn^Tk^rTn^.

The principal radii of curvature of the reflected ray ρ1r and ρ2r are the non-zero eigenvalues of Qr(q) while the principal directions x^1r and x^2r are given by the associated eigenvectors. With these definitions, we are now able to express the reflected field at point r=q+sk^r as a function of the incoming field at point q (Eq.23) [Vitucci24]:

(51)Er,m(r)=pmAm(q)ejχm(q)ρ1rρ2r(ρ1r+s)(ρ2r+s)×(Ei,θ(q)θ^(k^r)+Ei,φ(q)φ^(k^r))ejk0s

where we have assumed, as in (44), that the RIS does not realize any polarization transformation.

References:
[atan2]

Wikipedia, “atan2,” accessed 8 Feb. 2023.

[Balanis]

A. Balanis, “Advanced Engineering Electromagnetics,” John Wiley & Sons, 2012.

[Degli-Esposti07] (1,2,3)

V. Degli-Esposti et al., “Measurement and modelling of scattering from buildings,” IEEE Trans. Antennas Propag, vol. 55, no. 1, pp.143-153, Jan. 2007.

[Degli-Esposti11]

V. Degli-Esposti et al., “Analysis and Modeling on co- and Cross-Polarized Urban Radio Propagation for Dual-Polarized MIMO Wireless Systems”, IEEE Trans. Antennas Propag, vol. 59, no. 11, pp.4247-4256, Nov. 2011.

[Degli-Esposti22] (1,2,3)

V. Degli-Esposti et al., “Reradiation and Scattering From a Reconfigurable Intelligent Surface: A General Macroscopic Model”, IEEE Trans. Antennas Propag, vol. 70, no. 10, pp.8691-8706, Oct. 2022.

[Di-Renzo20]

M. Di Renzo et al., “Smart Radio Environments Empowered by Reconfigurable Intelligent Surfaces: How It Works, State of Research, and The Road Ahead”, IEEE J. Sel. Areas Commun., vol. 38, no. 11 pp.2450-2525, Nov. 2020.

[Fresnel]

Wikipedia, “Fresnel integral,” accessed 21 Apr. 2023.

[ITURP52615] (1,2)

ITU, “Recommendation ITU-R P.526-15: Propagation by diffraction,” Oct. 2019.

[Keller62]

J. B. Keller, “Geometrical Theory of Diffraction,” Journal of the Optical Society of America, vol. 52, no. 2, Feb. 1962.

[Kline]

M. Kline, “An Asymptotic Solution of Maxwell’s Equations,” Commun. Pure Appl. Math., vol. 4, 1951.

[Kouyoumjian74] (1,2,3)

R. G. Kouyoumjian, “A uniform geometrical theory of diffraction for an edge in a perfectly conducting surface,” Proc. of the IEEE, vol. 62, no. 11, Nov. 1974.

[Luebbers84] (1,2,3)

R. Luebbers, “Finite conductivity uniform GTD versus knife edge diffraction in prediction of propagation path loss,” IEEE Trans. Antennas and Propagation, vol. 32, no. 1, Jan. 1984.

[Luneberg]

R. M. Luneberg, “Mathematical Theory of Optics,” Brown University Press, 1944.

[McNamara90] (1,2,3)

D. A. McNamara, C.W.I. Pistorius, J.A.G. Malherbe, “Introduction to the Uniform Geometrical Theory of Diffraction,” Artech House, 1990.

[METIS]

METIS Deliverable D1.4, “METIS Channel Models”, Feb. 2015.

[Tse]

D. Tse, P. Viswanath, “Fundamentals of Wireless Communication”, Cambridge University Press, 2005.

[Vitucci24] (1,2,3,4,5,6,7,8)

E. M. Vittuci et al., “An Efficient Ray-Based Modeling Approach for Scattering From Reconfigurable Intelligent Surfaces”, IEEE Trans. Antennas Propag, vol. 72, no. 3, pp.2673-2685, Mar. 2024.

[Wiesbeck]

N. Geng and W. Wiesbeck, “Planungsmethoden für die Mobilkommunikation,” Springer, 1998.

[Wikipedia]

Wikipedia, “Maximum power transfer theorem,” accessed 7 Oct. 2022.

[Wikipedia_Rodrigues]

Wikipedia, “Rodrigues’ rotation formula,” accessed 16 Jun. 2023.

[Pharr]

M. Pharr, J. Wenzel, G. Humphreys, “Physically Based Rendering: From Theory to Implementation,” MIT Press, 2023.