Main Content

fixed.complexQlessQRMatrixSolveFixedpointTypes

Determine fixed-point types for matrix solution of complex-valued A'AX=B using QR decomposition

Since R2021b

Description

example

T = fixed.complexQlessQRMatrixSolveFixedpointTypes(m,n,max_abs_A,max_abs_B,precisionBits) computes fixed-point types for the matrix solution of complex-valued A'AX=B using QR decomposition. T is returned as a struct with fields that specify fixed-point types for A and B that guarantee no overflow will occur in the QR algorithm transforming A in-place into upper-triangular R, where QR=A is the QR decomposition of X, and X such that there is a low probability of overflow.

example

T = fixed.complexQlessQRMatrixSolveFixedpointTypes(___,noiseStandardDeviation) specifies the standard deviation of the additive random noise in A. noiseStandardDeviation is an optional parameter. If not supplied or empty, then the default value is used.

example

T = fixed.complexQlessQRMatrixSolveFixedpointTypes(___,p_s) specifies the probability that the estimate of the lower bound for the smallest singular value of A is larger than the actual smallest singular value of the matrix. p_s is an optional parameter. If not supplied or empty, then the default value is used.

example

T = fixed.complexQlessQRMatrixSolveFixedpointTypes(___,regularizationParameter) computes fixed-point types for the matrix solution of complex-valued

[λInA]'[λInA]X=(λ2In+A'A)X=B

where λ is the regularizationParameter, A is an m-by-n matrix, and In = eye(n). regularizationParameter is an optional parameter. If not supplied or empty, then the default value is used.

T = fixed.complexQlessQRMatrixSolveFixedpointTypes(___,maxWordLength) specifies the maximum word length of the fixed-point types. maxWordLenth is an optional parameter. If not supplied or empty, then the default value is used.

Examples

collapse all

This example shows how to use the fixed.complexQlessQRMatrixSolveFixedpointTypes function to analytically determine fixed-point types for the solution of the complex least-squares matrix equation AAX=B, where A is an m-by-n matrix with mn, B is n-by-p, and X is n-by-p.

Fixed-point types for the solution of the matrix equation AAX=B are well-bounded if the number of rows, m, of A are much greater than the number of columns, n (i.e. mn), and A is full rank. If A is not inherently full rank, then it can be made so by adding random noise. Random noise naturally occurs in physical systems, such as thermal noise in radar or communications systems. If m=n, then the dynamic range of the system can be unbounded, for example in the scalar equation x=a/b and a,b[-1,1], then x can be arbitrarily large if b is close to 0.

Define System Parameters

Define the matrix attributes and system parameters for this example.

m is the number of rows in matrix A. In a problem such as beamforming or direction finding, m corresponds to the number of samples that are integrated over.

m = 300;

n is the number of columns in matrix A and rows in matrices B and X. In a least-squares problem, m is greater than n, and usually m is much larger than n. In a problem such as beamforming or direction finding, n corresponds to the number of sensors.

n = 10;

p is the number of columns in matrices B and X. It corresponds to simultaneously solving a system with p right-hand sides.

p = 1;

In this example, set the rank of matrix A to be less than the number of columns. In a problem such as beamforming or direction finding, rank(A) corresponds to the number of signals impinging on the sensor array.

rankA = 3;

precisionBits defines the number of bits of precision required for the matrix solve. Set this value according to system requirements.

precisionBits = 24;

In this example, complex-valued matrices A and B are constructed such that the magnitude of the real and imaginary parts of their elements is less than or equal to one, so the maximum possible absolute value of any element is |1+1i|=2. Your own system requirements will define what those values are. If you don't know what they are, and A and B are fixed-point inputs to the system, then you can use the upperbound function to determine the upper bounds of the fixed-point types of A and B.

max_abs_A is an upper bound on the maximum magnitude element of A.

max_abs_A = sqrt(2);

max_abs_B is an upper bound on the maximum magnitude element of B.

max_abs_B = sqrt(2);

Thermal noise standard deviation is the square root of thermal noise power, which is a system parameter. A well-designed system has the quantization level lower than the thermal noise. Here, set thermalNoiseStandardDeviation to the equivalent of -50dB noise power.

thermalNoiseStandardDeviation = sqrt(10^(-50/10))
thermalNoiseStandardDeviation = 0.0032

The quantization noise standard deviation is a function of the required number of bits of precision. Use fixed.complexQuantizationNoiseStandardDeviation to compute this. See that it is less than thermalNoiseStandardDeviation.

quantizationNoiseStandardDeviation = fixed.complexQuantizationNoiseStandardDeviation(precisionBits)
quantizationNoiseStandardDeviation = 2.4333e-08

Compute Fixed-Point Types

In this example, assume that the designed system matrix A does not have full rank (there are fewer signals of interest than number of columns of matrix A), and the measured system matrix A has additive thermal noise that is larger than the quantization noise. The additive noise makes the measured matrix A have full rank.

Set σnoise=σthermal noise.

noiseStandardDeviation = thermalNoiseStandardDeviation;

Use the fixed.complexQlessQRMatrixSolveFixedpointTypes function to compute fixed-point types.

T = fixed.complexQlessQRMatrixSolveFixedpointTypes(m,n,max_abs_A,max_abs_B,...
    precisionBits,noiseStandardDeviation)
T = struct with fields:
    A: [0x0 embedded.fi]
    B: [0x0 embedded.fi]
    X: [0x0 embedded.fi]

T.A is the type computed for transforming A to R=QA in-place so that it does not overflow.

T.A
ans = 

[]

          DataTypeMode: Fixed-point: binary point scaling
            Signedness: Signed
            WordLength: 32
        FractionLength: 24

T.B is the type computed for B so that it does not overflow.

T.B
ans = 

[]

          DataTypeMode: Fixed-point: binary point scaling
            Signedness: Signed
            WordLength: 27
        FractionLength: 24

T.X is the type computed for the solution X=(AA)\B so that there is a low probability that it overflows.

T.X
ans = 

[]

          DataTypeMode: Fixed-point: binary point scaling
            Signedness: Signed
            WordLength: 40
        FractionLength: 24

Use the Specified Types to Solve the Matrix Equation A'AX=B

Create random matrices A and B such that rankA=rank(A). Add random measurement noise to A which will make it become full rank.

rng('default');
[A,B] = fixed.example.complexRandomQlessQRMatrices(m,n,p,rankA);
A = A + fixed.example.complexNormalRandomArray(0,noiseStandardDeviation,m,n);

Cast the inputs to the types determined by fixed.complexQlessQRMatrixSolveFixedpointTypes. Quantizing to fixed-point is equivalent to adding random noise.

A = cast(A,'like',T.A);
B = cast(B,'like',T.B);

Accelerate the fixed.qlessQRMatrixSolve function by using fiaccel to generate a MATLAB executable (MEX) function.

fiaccel fixed.qlessQRMatrixSolve -args {A,B,T.X} -o qlessQRMatrixSolve_mex

Specify output type T.X and compute fixed-point X=(AA)\B using the QR method.

X = qlessQRMatrixSolve_mex(A,B,T.X);

Compute the relative error to verify the accuracy of the output.

relative_error = norm(double(A'*A*X - B))/norm(double(B))
relative_error = 0.1091

Suppress mlint warnings in this file.

%#ok<*NASGU>
%#ok<*ASGLU>

This example shows how to use the fixed.complexQlessQRMatrixSolveFixedpointTypes function to analytically determine fixed-point types for the solution of the complex least-squares matrix equation

[λInA]H[λInA]X=(λ2In+AHA)X=B

where A is an m-by-n matrix with mn, B is n-by-p, X is n-by-p, In=eye(n), and λ is a regularization parameter.

Define System Parameters

Define the matrix attributes and system parameters for this example.

m is the number of rows in matrix A. In a problem such as beamforming or direction finding, m corresponds to the number of samples that are integrated over.

m = 300;

n is the number of columns in matrix A and rows in matrices B and X. In a least-squares problem, m is greater than n, and usually m is much larger than n. In a problem such as beamforming or direction finding, n corresponds to the number of sensors.

n = 10;

p is the number of columns in matrices B and X. It corresponds to simultaneously solving a system with p right-hand sides.

p = 1;

In this example, set the rank of matrix A to be less than the number of columns. In a problem such as beamforming or direction finding, rank(A) corresponds to the number of signals impinging on the sensor array.

rankA = 3;

precisionBits defines the number of bits of precision required for the matrix solve. Set this value according to system requirements.

precisionBits = 32;

Small, positive values of the regularization parameter can improve the conditioning of the problem and reduce the variance of the estimates. While biased, the reduced variance of the estimate often results in a smaller mean squared error when compared to least-squares estimates.

regularizationParameter = 0.01;

In this example, complex-valued matrices A and B are constructed such that the magnitude of the real and imaginary parts of their elements is less than or equal to one, so the maximum possible absolute value of any element is |1+1i|=2. Your own system requirements will define what those values are. If you don't know what they are, and A and B are fixed-point inputs to the system, then you can use the upperbound function to determine the upper bounds of the fixed-point types of A and B.

max_abs_A is an upper bound on the maximum magnitude element of A.

max_abs_A = sqrt(2);

max_abs_B is an upper bound on the maximum magnitude element of B.

max_abs_B = sqrt(2);

Thermal noise standard deviation is the square root of thermal noise power, which is a system parameter. A well-designed system has the quantization level lower than the thermal noise. Here, set thermalNoiseStandardDeviation to the equivalent of -50dB noise power.

thermalNoiseStandardDeviation = sqrt(10^(-50/10))
thermalNoiseStandardDeviation = 0.0032

The quantization noise standard deviation is a function of the required number of bits of precision. Use fixed.complexQuantizationNoiseStandardDeviation to compute this. See that it is less than thermalNoiseStandardDeviation.

quantizationNoiseStandardDeviation = fixed.complexQuantizationNoiseStandardDeviation(precisionBits)
quantizationNoiseStandardDeviation = 9.5053e-11

Compute Fixed-Point Types

In this example, assume that the designed system matrix A does not have full rank (there are fewer signals of interest than number of columns of matrix A), and the measured system matrix A has additive thermal noise that is larger than the quantization noise. The additive noise makes the measured matrix A have full rank.

Set σnoise=σthermal noise.

noiseStandardDeviation = thermalNoiseStandardDeviation;

Use the fixed.complexQlessQRMatrixSolveFixedpointTypes function to compute fixed-point types.

T = fixed.complexQlessQRMatrixSolveFixedpointTypes(m,n,max_abs_A,max_abs_B,...
    precisionBits,noiseStandardDeviation,[],regularizationParameter)
T = struct with fields:
    A: [0x0 embedded.fi]
    B: [0x0 embedded.fi]
    X: [0x0 embedded.fi]

T.A is the type computed for transforming [λInA] to R=QH[λInA] in-place so that it does not overflow.

T.A
ans = 

[]

          DataTypeMode: Fixed-point: binary point scaling
            Signedness: Signed
            WordLength: 40
        FractionLength: 32

T.B is the type computed for B so that it does not overflow.

T.B
ans = 

[]

          DataTypeMode: Fixed-point: binary point scaling
            Signedness: Signed
            WordLength: 35
        FractionLength: 32

T.X is the type computed for the solution X=([λInA]H[λInA])\B so that there is a low probability that it overflows.

T.X
ans = 

[]

          DataTypeMode: Fixed-point: binary point scaling
            Signedness: Signed
            WordLength: 48
        FractionLength: 32

Use the Specified Types to Solve the Matrix Equation

Create random matrices A and B such that rankA=rank(A). Add random measurement noise to A which will make it become full rank.

rng('default');
[A,B] = fixed.example.complexRandomQlessQRMatrices(m,n,p,rankA);
A = A + fixed.example.complexNormalRandomArray(0,noiseStandardDeviation,m,n);

Cast the inputs to the types determined by fixed.complexQlessQRMatrixSolveFixedpointTypes. Quantizing to fixed-point is equivalent to adding random noise.

A = cast(A,'like',T.A);
B = cast(B,'like',T.B);

Accelerate the fixed.qlessQRMatrixSolve function by using fiaccel to generate a MATLAB executable (MEX) function.

fiaccel +fixed/qlessQRMatrixSolve -args {A,B,T.X,[],regularizationParameter} -o qlessQRMatrixSolve_mex

Specify output type T.X and compute fixed-point X=([λInA]H[λInA])\B using the QR method.

X = qlessQRMatrixSolve_mex(A,B,T.X,[],regularizationParameter);

Verify the Accuracy of the Output

Verify that the relative error between the fixed-point output and builtin MATLAB in double-precision floating-point is small.

Xdouble=([λInA]H[λInA])\B

A_lambda = double([regularizationParameter*eye(n);A]);
X_double = (A_lambda'*A_lambda)\double(B);
relativeError = norm(X_double - double(X))/norm(X_double)
relativeError = 1.1103e-05

Suppress mlint warnings in this file.

%#ok<*NASGU>
%#ok<*ASGLU>

Input Arguments

collapse all

Number of rows in A and B, specified as a positive integer-valued scalar.

Data Types: double

Number of columns in A, specified as a positive integer-valued scalar.

Data Types: double

Maximum of the absolute value of A, specified as a scalar.

Example: max(abs(A(:)))

Data Types: double

Maximum of the absolute value of B, specified as a scalar.

Example: max(abs(B(:)))

Data Types: double

Required number of bits of precision of the input and output, specified as a positive integer-valued scalar.

Data Types: double

Standard deviation of additive random noise in A, specified as a scalar.

If noiseStandardDeviation is not specified, then the default is the standard deviation of the complex-valued quantization noise σq=(2precisionBits)/(6), which is calculated by fixed.complexQuantizationNoiseStandardDeviation.

Data Types: double

Probability that estimate of lower bound s is larger than actual smallest singular value of matrix, specified as a scalar. Use fixed.complexSingularValueLowerBound to estimate the smallest singular value, s, of A. If p_s is not specified, the default value is ps=(1/2)(1+erf(5/2))3107 which is 5 standard deviations below the mean, so the probability that the estimated bound for the smallest singular value is less than the actual smallest singular value is 1-ps ≈ 0.9999997.

Data Types: double

Regularization parameter, specified as a nonnegative scalar. Small, positive values of the regularization parameter can improve the conditioning of the problem and reduce the variance of the estimates. While biased, the reduced variance of the estimate often results in a smaller mean squared error when compared to least-squares estimates.

regularizationParameter is the Tikhonov regularization parameter of the matrix problem

[λInA]'[λInA]X=(λ2In+A'A)X=B

Data Types: single | double | int8 | int16 | int32 | int64 | uint8 | uint16 | uint32 | uint64 | fi

Maximum word length of fixed-point types, specified as a positive integer.

If the word length of the fixed-point type exceeds the specified maximum word length, the default of 128 bits is used.

Data Types: single | double | int8 | int16 | int32 | int64 | uint8 | uint16 | uint32 | uint64 | fi

Output Arguments

collapse all

Fixed-point types for A, B, and X, returned as a struct. The struct T has fields T.A, T.B, and T.X. These fields contain fi objects that specify fixed-point types for

  • A and B that guarantee no overflow will occur in the QR algorithm.

    The QR algorithm transforms A in-place into upper-triangular R where QR=A is the QR decomposition of A.

  • X such that there is a low probability of overflow.

Algorithms

The fixed-point type for A is computed using fixed.qlessqrFixedpointTypes. The required number of integer bits to prevent overflow is derived from the following bound on the growth of R [1]. The required number of integer bits is added to the number of bits of precision, precisionBits, of the input, plus one for the sign bit, plus one bit for intermediate CORDIC gain of approximately 1.6468 [2].

The elements of R are bounded in magnitude by

max(|R(:)|)mmax(|A(:)|).

Matrix B is not transformed, so it does not need any additional growth bits.

The elements of X=R\(R'\B) are bounded in magnitude by

max(|X(:)|)nmax(|B(:)|)min(svd(A))2.

Computing the singular value decomposition to derive the above bound on X is more computationally intensive than the entire matrix solve, so the fixed.complexSingularValueLowerBound function is used to estimate a bound on min(svd(A)).

References

[2] Voler, Jack E. "The CORDIC Trigonometric Computing Technique." IRE Transactions on Electronic Computers EC-8 (1959): 330-334.

Version History

Introduced in R2021b

expand all