Next Article in Journal
Contactless Vital Sign Monitoring: A Review Towards Multi-Modal Multi-Task Approaches
Previous Article in Journal
Dual-Branch Deep Learning with Dynamic Stage Detection for CT Tube Life Prediction
Previous Article in Special Issue
Gramian Angular Field and Convolutional Neural Networks for Real-Time Multiband Spectrum Sensing in Cognitive Radio Networks
 
 
Font Type:
Arial Georgia Verdana
Font Size:
Aa Aa Aa
Line Spacing:
Column Width:
Background:
Article

Spectrum Sensing for Noncircular Signals Using Augmented Covariance-Matrix-Aware Deep Convolutional Neural Network

1
Southwest China Institute of Electronic Technology, Chengdu 610036, China
2
School of Aeronautics and Astronautics, Sichuan University, Chengdu 610065, China
3
Multi-Source Information Intelligent Fusion Key Laboratory of Sichuan Province, Chengdu 610065, China
4
Robotic Satellite Key Laboratory of Sichuan Province, Chengdu 610015, China
*
Author to whom correspondence should be addressed.
Sensors 2025, 25(15), 4791; https://doi.org/10.3390/s25154791
Submission received: 2 July 2025 / Revised: 27 July 2025 / Accepted: 31 July 2025 / Published: 4 August 2025

Abstract

This work investigates spectrum sensing in cognitive radio networks, where multi-antenna secondary users aim to detect the spectral occupancy of noncircular signals transmitted by primary users. Specifically, we propose a deep-learning-based spectrum sensing approach using an augmented covariance-matrix-aware convolutional neural network (CNN). The core innovation of our approach lies in employing an augmented sample covariance matrix, which integrates both a standard covariance matrix and complementary covariance matrix, thereby fully exploiting the statistical properties of noncircular signals. By feeding augmented sample covariance matrices into the designed CNN architecture, the proposed approach effectively learns discriminative patterns from the underlying data structure, without stringent model constraints. Meanwhile, our approach eliminates the need for restrictive model assumptions and significantly enhances the detection performance by fully exploiting noncircular signal characteristics. Various experimental results demonstrate the significant performance improvement and generalization capability of the proposed approach compared to existing benchmark methods.

1. Introduction

The increasing demand for high-speed wireless communication has led to a growing need for spectrum resources [1]. However, the traditional static spectrum allocation policy grants exclusive access to licensed spectrum bands for primary users (PUs), leaving secondary users (SUs) unable to utilize these resources, even when they are idle. To address this inefficiency, cognitive radio (CR) technology has been introduced [2]. As a paradigm of software-defined radio, CR offers a promising solution to the spectrum scarcity problem by enabling dynamic spectrum access, thereby accommodating the escalating data rate requirements in wireless communications [3,4]. In fact, CR systems enhance spectral efficiency by opportunistically allowing SUs to access an underutilized spectrum without causing harmful interference to PUs (a concept known as spectrum reuse). To enable this, SUs must continuously perform spectrum sensing, which involves reliably detecting the presence or absence of PUs in a given frequency band. As such, spectrum sensing constitutes a fundamental function of cognitive radio systems and has become a central research topic in both academia and industry [5,6,7].
In the past few years, numerous approaches have been proposed to address the critical challenge of spectrum sensing in CR systems. Among these, energy detection (ED) [8] stands as a mature technique to determine spectrum occupancy by comparing the received signal power against a threshold derived from the prior noise power. However, its performance is highly susceptible to noise uncertainty, due to the dynamic and often unknown nature of noise power in practical environments. Subsequently, maximum eigenvalue detection (MED) [9] emerged by leveraging the eigenvalue properties of a sampled covariance matrix, which also critically relies on prior knowledge of noise variance, making it similarly vulnerable to noise uncertainty [10]. To overcome the reliance on prior noise power estimation and improve performance in non-independent and identically distributed noise environments, several advanced techniques have been developed. Notable examples include eigenvalue moment ratio (EMR) [11], Hadamard ratio detection (HDM) [12], and largest absolute value (LAV) detection [13]. While these methods demonstrate improved robustness against noise uncertainty, they frequently exhibit degraded performance in challenging scenarios such as low signal-to-noise ratio conditions and unstable noise distributions. Importantly, all of the aforementioned approaches are fundamentally model-driven, relying on predefined statistical assumptions and manually designed features. Their effectiveness is thus inherently constrained by the validity of these assumptions.
In contrast to model-driven approaches, deep learning [14,15] has emerged as a powerful paradigm for spectrum sensing, leveraging its capability to autonomously extract discriminative features from raw data, without relying on predefined statistical models. CNNs [16] have been widely adopted due to their proficiency in capturing spatial structures within signal representations. Pioneering this direction, the CM-CNN [17] utilizes a sample covariance matrix (CM) as input to learn environment-adaptive test statistics, and Gao et al. [18] directly processed raw I/Q samples through deep neural networks to exploit their inherent modulation structures. Further innovations have integrated temporal dynamics. For example, the authors in [19] processed both current and historical sensing data, to implicitly model primary user activity patterns, while CNN-LSTM (long short-term memory) [20] combines CNN spatial feature extraction with LSTM sequential modeling to exploit time-dependent signal correlations. For enhanced signal characterization, the method in [21] employs time–frequency representations derived from short-time Fourier transform to capture joint time–frequency features. Recent advances have mainly focused on cross-user interactions and advanced architectures: CNN-Transformer [22] models inter-user signal dependencies through self-attention mechanisms, and channel-attention based parallel CNN-LSTM [23] uses attention-guided spatial feature refinement coupled with parallel temporal modeling.
While the aforementioned methods have demonstrated significant progress, they often implicitly exploit the circularity property of signals. Circular signals exhibit statistical properties that are rotationally invariant in the complex plane. However, not all practical digital modulation schemes produce circular signals. Non-circular (NC) signals, characterized by an asymmetric distribution of their constellation points in the complex plane, are frequently encountered in real-world CR systems. Prominent examples include binary phase shift keying (BPSK), unequal quadrature phase shift keying (UQPSK), and pulse amplitude modulation (PAM), etc. For such signals, valuable discriminatory information resides not only in the conventional covariance matrix, but also in the complementary covariance matrix. In consideration of this, researchers have developed enhanced spectrum sensing techniques specifically designed to leverage non-circularity. For instance, the NC-HDM method [24] extends the conventional HDM test by incorporating a complementary covariance matrix, significantly improving detection for NC signals compared to its circular counterpart. Similarly, the NC-LAV (largest absolute value) algorithm [25] integrates non-circular information into the LAV framework, yielding substantial performance gains over the original LAV method [13] in NC signal environments. Recently, the authors in [26] jointly exploited both covariance matrices for spectrum sensing under uncalibrated antennas. Nevertheless, these NC-enhanced techniques remain model-driven, inheriting fundamental limitations regarding adaptability to diverse and unstable noise environments.
Motivated by the strengths of CNNs for matrix-shaped data structures and the rich statistical structure inherent in non-circular (NC) signals, we propose an augmented covariance-matrix-aware convolutional neural network (ACM-CNN) for spectrum sensing in cognitive radio systems. The key innovation of the proposed method lies in the construction of an augmented covariance matrix that explicitly integrates both standard covariance and complementary covariance matrices. Such a joint representation enables comprehensive exploitation of both the second-order correlation and the non-circular features of the received signal. Unlike previous noncircular based methods that remain constrained by analytical mathematical models, the proposed ACM-CNN method leverages a data-driven approach to automatically learn complex and discriminative patterns embedded in the augmented matrix, thereby improving robustness to unstable noise and low-SNR conditions. Extensive simulation results demonstrate that ACM-CNN significantly outperformed existing state-of-the-art model-driven methods, as well as conventional deep-learning-based techniques, especially in scenarios involving non-circular signals and uncertain noise environments.
The remaining sections of this paper are organized as follows: Section 2 introduces the system model and the problem formulation. Section 3 presents the proposed spectrum sensing method using an augmented covariance-matrix-aware deep CNN. Section 4 evaluates the performance of the proposed algorithm via extensive numerical experiments. Finally, Section 5 concludes the paper.
Notation: We use the superscripts “∗”, “ T ”, and “ H ” to denote the conjugate, the transpose, and the conjugate transpose, respectively. For a vector x C n , we use x i to represent its i-th element. For a matrix X C m × n , x i j denotes the element at the intersection of its i-th row and j-th column. We use x CN ( x , μ ; Σ ) to denote that x follows real normal and complex circularly symmetric normal distributions with mean μ and covariance Σ , respectively. In addition, we use j 1 , 0 , and E ( · ) to denote the imaginary unit, the null matrix, and the expectation operation, respectively.

2. Signal Model

Let us consider a multi-antenna cognitive radio (CR) scenario, in which a secondary user (SU) with M receiving antennas aims to detect the radio spectrum hole of M 0 primary users (PUs) and seeks to opportunistically use this spectrum when the PUs are idle. Specifically, the SU is attempting to decide if any of the PUs are transmitting based on N available observations. Let x ( n ) = [ x 1 ( n ) , x 2 ( n ) , , x M ( n ) ] T denote the receiving discrete-time sample at time n of SU in the CR system. We assume that each PU in the CR system has one antenna, which transmits a signal or does not transmit a signal randomly over a certain spectrum with incumbent licensees. Therefore, there are just two states of the PU (active or inactive). As such, the spectrum sensing problem for a multi-antenna SU can be formulated as a binary hypothesis testing problem:
H 1 : x ( n ) = H s ( n ) + u ( n ) , H 0 : x ( n ) = u ( n ) ,
where H 1 stands for the signal-presence hypothesis; H 0 denotes the signal-absence hypothesis; H C M × M 0 denotes the channel matrix between the PU and the SU, which is usually unknown but deterministic during the sensing period (coherence time); s ( n ) = [ s 1 ( n ) , s 2 ( n ) , . . . , s M 0 ( n ) ] T denotes the signal vector emitted by PU at time n; u ( n ) = [ u 1 ( n ) , u 2 ( n ) , . . . , u M ( n ) ] T denotes the additive noise vector at time n.
We assume that s i ( n ) ( i = 1 , . . . , M 0 ) is exactly a non-circular signal, with its variance being σ s i 2 = E [ | s i 2 | ] and E [ s i 2 ] = κ i e j ϕ i σ s i with ϕ i [ π , π ) and κ i [ 0 , 1 ] being the noncircularity phase and the noncircularity rate, respectively. Moreover, we assume that the noise { u i ( n ) } i = 1 M is statistically independent of each other, independent of the signals, and follows a circular Gaussian distribution, i.e., E [ u i 2 ( n ) ] = 0 and u i ( n ) CN ( 0 , σ u i 2 ) ( i = 1 , , M ) , where σ u i 2 = E [ | u i 2 ( n ) | ] is the noise variance. Note that σ u i 2 is not necessarily equal to σ u j 2 for i j in practice, which corresponds to the case of an uncalibrated multiple antenna receiver [26]. As such, the augmented covariance matrix can be expressed as
R ̲ = E [ x ̲ ( n ) x ̲ T ( n ) ] = R R ˜ R ˜ R
where x ̲ ( n ) = [ x T ( n ) , x H ( n ) ] T denotes the augmented signal vector consisting of x ( n ) and x ( n ) and
R = E [ x ( n ) x H ( n ) ] , R ˜ = E [ x ( n ) x T ( n ) ] .
Herein, R and R ˜ stand for the conventional covariance matrix and the complementary covariance matrix, respectively. Note that if the signal vector of PU s ( n ) is noncircular, then we have R ˜ 0 , otherwise R ˜ = 0 . The commonly-used noncircular signals with R ˜ 0 can be the BPSK, offset QPSK, UQPSK, and minimum shift keying (GMSK) signal, etc.
Now, the spectrum sensing problem at hand is to decide whether the PU signals { s i ( n ) } i = 1 M 0 exist or not from the available N noisy observations { x ( n ) } n = 1 N . To fully exploit the full statistical property of noncircular signals and improve the detection performance, it is crucial to construct a test statistic using the augmented covariance matrix R ̲ . Typical model-driven methods include NC-HDM [24] and NC-LAV [25], which, however, cannot be applied to the case with uncertain or unstable noise. To address this, in the following, we use an augmented covariance-matrix-aware deep CNN, i.e., a data-driven approach, to learn a robust and generalized test statistic for enhancing the spectrum sensing performance of noncircular signals.

3. Spectrum Sensing Using Augmented Covariance-Matrix-Aware Deep CNN

In this section, we propose a deep-learning-based spectrum sensing framework based on augmented covariance-matrix-aware convolutional neural networks, which is illustrated in Figure 1. The proposed framework mainly consists of three stages: data preprocessing, offline training, and online detection, as will be elaborated as follows:

3.1. Data Preprocessing

In each sensing period, the SU collects N observations { x ( n ) } n = 1 N to perform a spectrum sensing. Here, we adopt the full second-order statistical sample covariance matrix of { x ( n ) } n = 1 N , i.e., the usual sample covariance matrix denoted as R ^ , while the complementary sample covariance matrix is denoted as R ˜ ^ . Both R ^ and R ˜ ^ are designed as the input of the CNN. The sample covariance matrix R ^ and complementary sample covariance matrix R ˜ ^ from N observations are, respectively, calculated as
R ^ = 1 N n = 0 N 1 x ( n ) x H ( n ) , R ˜ ^ = 1 N n = 0 N 1 x ( n ) x T ( n ) .
Then, we obtain an augmented sample covariance matrix
R ^ ̲ = R ^ R ˜ ^ R ˜ ^ R ^ .
The reason for using an augmented sample covariance matrix is that it contains not only the energy information but also the correlation information between antennas and between the usual covariance matrix and complementary covariance matrix. To facilitate subsequent processing by CNNs, which typically operate on real-valued inputs, we decompose the complex-valued augmented covariance matrix R ^ ̲ into its real and imaginary components. Specifically, we construct the input of CNNs as
R ̲ = R ^ ̲ R ^ ̲ = R R ˜ R ˜ R R 2 M × 2 M × 2 ,
where { · } and { · } denote the real and imaginary components, respectively; and [ · · ] denotes the stacking operation of a matrix to form a three-dimensional tensor. In a word, the two real-valued matrices R ^ ̲ and R ^ ̲ are concatenated along a new dimension to form a three-dimensional augmented covariance tensor R ̲ . Similarly, R , R ˜ , R ˜ , and R represent the tensor formed by stacking the real and imaginary parts of R ^ , R ˜ ^ , R ˜ ^ , and R ^ , respectively.
Meanwhile, the binary hypothesis labels are encoded as one-hot vectors to align with the output layer of the CNN classifier:
H 1 z = [ 1 , 0 ] T
H 0 z = [ 0 , 1 ] T .
This representation enables the CNN network to output class probabilities directly, where the first element in z corresponds to the probability of H 1 and the second to the probability of H 0 .
The unitization of the augmented sample covariance matrix in Equation (5) has significant advantages in spectrum sensing for noncircular PU signals. Specifically, it can contribute to learning more discriminative patterns and a generalized test statistic. To illustrate this, we consider a noncircular signal case with N = 100,000 and M = 8 , where the matrix-shaped heatmaps of the real and imaginary parts of R ^ ̲ under H 1 and H 0 are shown in Figure 2 for comparison. Herein, Figure 2a,b represent the real parts of the augmented covariance matrix under the presence and absence of the primary user signal, respectively, while Figure 2c,d show the corresponding imaginary parts. The two block matrices along the main diagonal correspond to the conventional covariance matrices, whereas the off-diagonal blocks represent the complementary covariance matrices (also known as pseudo-covariance). It is seen that the pseudo-covariance matrices (i.e., the off-diagonal blocks) exhibit a clear distinction between the cases with and without the presence of the primary user signal. This indicates that the pseudo-covariance of non-circular signals provides additional discriminative information that can be effectively used to distinguish between signal presence and absence, thereby enabling the learning of a more accurate data-driven test statistic.

3.2. Offline Training for Spectrum Sensing of Noncircular Signals

In the offline training stage, the labeled K training samples for spectrum sensing are collected to construct the training set:
( Y , Z ) = { ( y ( 1 ) , z ( 1 ) ) , ( y ( 2 ) , z ( 2 ) ) , , ( y ( K ) , z ( K ) ) }
where ( y ( k ) , z ( k ) ) denotes the k - th ( k = 1 , 2 , , K ) training sample of the training set ( Y , Z ) . For a single example ( y , z ) , y represents the input data for the neural network, which is the augmented covariance matrix calculated by Equation (5). We note that z { [ 0 , 1 ] T , [ 1 , 0 ] T } represents the corresponding label of H 0 and H 1 . The output of CNN is formulated as a normalized class score vector:
h θ ( y ( k ) ) = h θ | H 1 ( y ( k ) ) h θ | H 0 ( y ( k ) ) ,
where h θ | H 1 ( y ( k ) ) + h θ | H 0 ( y ( k ) ) = 1 . We note that h θ ( · ) is a mapping from y ( k ) to z ( k ) with CNN parameters θ . In this case, h θ | H i ( y ( k ) ) represents the class score under H i . Because the output of CNN behaves like a probability distribution, we can define the loss function L ( θ ) using cross-entropy as
L ( θ ) 1 K k = 1 K z 1 ( k ) log h θ | H 1 ( y ( k ) ) + ( 1 z 1 ( k ) ) log ( 1 h θ | H 1 ( y ( k ) ) )
where z 1 ( k ) denotes the first element of z ( k ) . A smaller loss function value L ( θ ) indicates that the output of CNN, i.e., h θ ( y ( k ) ) , and the label z ( k ) tend to be closer. Our objective is to derive the optimal parameter θ that minimizes the loss function L ( θ ) , that is
θ = arg min θ L ( θ ) .
However, obtaining a closed-form analytical solution for L ( θ ) is intractable. We therefore employ gradient descent methods to compute a suboptimal solution. Based on Bayesian criterion, we have
P ( y | H 1 ) = P ( H 1 | y ) · P ( y ) P ( H 1 ) = h θ | H 1 ( y ) · P ( y ) P ( H 1 ) P ( y | H 0 ) = P ( H 0 | y ) · P ( y ) P ( H 0 ) = h θ | H 0 ( y ) · P ( y ) P ( H 0 ) ,
where P ( y | H i ) denotes the conditional probability given H i , P ( y ) is the marginal probability, and P ( H i ) indicates the priori probability of H i in the training process.
According to the Neyman–Pearson theorem, we can obtain a CNN-based likelihood ratio test:
T CNN ( y ) = h θ | H 1 ( y ) h θ | H 0 ( y ) · P ( H 0 ) P ( H 1 ) = h θ | H 1 ( y ) h θ | H 0 ( y ) γ ,
where the test statistic T CNN ( y ) denotes the CNN-based likelihood ratio, and the threshold γ can be derived from the false alarm constraint. For the convenience of analysis, we set P ( H 1 ) = P ( H 0 ) = 0.5 in the training process.

3.3. Covariance-Matrix-Aware CNN Structure

Note that CNNs exhibit strong capabilities for extracting discriminative features from tensor-shaped data, such as images. Motivated by this property, we leverage CNNs to extract informative features from a tensor-shaped representation R ̲ for spectrum sensing of noncircular signals.
We design a CNN-based architecture composed of two convolutional layers, followed by two fully connected layers, as illustrated in Figure 3. Specifically, C i ( 1 i 2 ) and F i ( 1 i 2 ) denote the i-th convolutional and fully connected layers, respectively. Each convolutional layer is followed by a rectified linear unit (ReLU) activation function to introduce non-linearity and enhance the representational capacity of the network. The first convolutional layer C 1 is responsible for capturing local spatial features and correlations in R ̲ , while the second layer C 2 further integrates and abstracts higher-level semantic features from the previous representations. The output of the convolutional layers is then reshaped into a one-dimensional feature vector via a flattening operation, which is subsequently passed to the first fully connected layer F 1 , with ReLU activation for further high-level reasoning. The final fully connected layer F 2 generates a two-dimensional output vector, which is passed through a softmax function to obtain the posterior probability of each class.
It is worth noting that, unlike typical CNN designs, we do not adopt pooling layers in the proposed CNN architecture. Although pooling operations such as max-pooling or average-pooling can reduce the spatial resolution and computational cost, they inevitably lead to the loss of fine-grained feature details. In spectrum sensing, the presence or absence of weak signals may rely on subtle variations in local structures, and retaining full spatial information is essential to ensure reliable detection performance. Therefore, our structure maintains the original resolution in the convolutional feature maps to preserve as much discriminative information as possible.

3.4. Online Detection for Spectrum Sensing of Noncircular Signals

For online detection, the multi-antenna SU collects an unlabeled sample y ˜ and then sends y ˜ to the well-trained CNN model h θ ( · ) of (14) to obtain the following test statistic:
T CNN ( y ˜ ) = h θ | H 1 ( y ˜ ) h θ | H 0 ( y ˜ ) H 0 H 1 γ .
Once we have obtained the test statistic T CNN ( y ˜ ) , we can quickly make a decision by comparing it with a preset threshold γ . The selection of the threshold γ is determined using the desired probability of false alarm P f . The procedure for how to obtain the threshold γ is detailed in Algorithm 1. In addition, for clarification, we summarize the above overall spectrum sensing procedure for noncircular signals in Algorithm 2, which is referred to as the augmented covariance matrix CNN (ACM-CNN) algorithm, where I max is the maximum number of iterations.
Algorithm 1 Selection of threshold γ using desired probability of false alarm P f
1:
Construct Y 0 = { y ( k ) | z ( k ) = 0 , 1 k K } from the training dataset ( Y , Z ) = { ( y ( 1 ) , z ( 1 ) ) , ( y ( 2 ) , z ( 2 ) ) , , ( y ( K ) , z ( K ) ) } , where z ( k ) = 0 indicates that the k-th training sample is generated under H 0 , and K 0 denotes the number of samples of Y 0 that satisfy z ( k ) = 0 , k { 1 , , K } , in Y;
2:
for   k 0 = 1 to K 0  do
3:
 Compute the test statistic T CNN ( y 0 ( k 0 ) ) = h θ H 1 ( y 0 ( k 0 ) ) h θ H 0 ( y 0 ( k 0 ) ) where y 0 ( k 0 ) Y 0 ;
4:
end for
5:
Sort the K 0 test statistics T CNN ( y 0 ( k 0 ) ) in ascending order as T CNN ( 1 ) T CNN ( 2 ) T CNN ( K 0 ) ;
6:
Determine the index corresponding to P f as per k = ( 1 P f ) K 0 where · denotes rounding to the nearest integer;
7:
Set the decision threshold: γ = T CNN ( k ) .
Algorithm 2 ACM-CNN
% Data Preprocessing
1:
Acquire discrete-time observation signals { x ( n ) } n = 1 N by sampling the received signals from M antennas;
2:
Compute the augmented covariance tensor R ̲ based on { x ( n ) } n = 1 N using Equations (4)–(6);
% Offline Training Phase
1:
Construct the labeled training dataset ( Y , Z ) = { ( y ( 1 ) , z ( 1 ) ) , ( y ( 2 ) , z ( 2 ) ) , , ( y ( K ) , z ( K ) ) } ;
2:
Initialize the CNN model parameters θ ( 0 ) and set iteration counter i = 0 ;
3:
for   i = 1 to I max  do
4:
   Compute the loss function L ( θ ( i ) ) using Equation (11);
5:
   Update the model parameters θ ( i ) using the Adam optimizer [27];
6:
end for
7:
Obtain the final model parameters θ θ ( i ) ;
% Online Detection Phase
1:
Set the decision threshold γ > 0 according to Algorithm 1;
2:
Acquire unlabeled test data y ˜ ;
3:
Input y ˜ into the trained CNN model to obtain the predicted result z ˜ ;
4:
Make spectrum occupancy decision by comparing each z ˜ with threshold γ : decide H 1 (occupied) if z ˜ > γ , otherwise decide H 0 (idle), as described in Equation (15).

4. Simulation Results

This section presents numerical experiments to corroborate the performance of the proposed ACM-CNN algorithm. We consider a multi-antenna CR system, where a PU randomly chooses to transmit a non-circular signal or not using M 0 = 4 antennas, and a SU equipped with M = 8 antennas receives the PU signals and attempts to determine whether the PU is active or inactive. The transmitted signals are noncircularity and complex Gaussian distributed, i.e., s k ( n ) CN ( 0 , σ s 2 ) ( k = 1 , , M 0 ), and the noncircularity rate is given as κ = E [ s k ( n ) 2 ] E [ | s k ( n ) | 2 ] . Except for the last experiment to explore the detection performance of different methods versus noncircularity rate κ , the rest of the numerical experiments are carried out under the condition of κ = 0.99 . The noises for the different receive antennas { u m ( n ) } m = 1 M are statistically independent and also independent of the PU signals. Specifically, the noises are generalized according to
u 1 ( n ) u 2 ( n ) u M ( n ) = σ a 1 σ a 2 σ a K u 1 0 ( n ) u 2 0 ( n ) u M 0 ( n ) σ t 1 σ t 2 σ t N ,
where u m 0 ( n ) is a standard circularly symmetric complex Gaussian noise, i.e., u m 0 ( n ) CN ( 0 , 1 ) , and σ a m 2 and σ t n 2 indicate the noise variances across antennas and time, respectively. Furthermore, the logarithmic values of σ a m 2 and σ t n 2 are assumed to follow uniform distributions to construct the noise uncertainty. Specifically, they are defined as
10 log 10 σ a m 2 U ( ε a , ε a ) , 10 log 10 σ t n 2 U ( ε t , ε t ) .
where U ( a , b ) denote the uniform distributions from a to b. Meanwhile, ε a and ε a represent the uncertainty factors of the noise variance for the antennas and time, respectively, which are used to characterize the degree of fluctuation of the noise power in decibels (dB). The signal-to-noise ratio (SNR) is defined as
SNR 10 log 10 M N σ s 2 m = 1 M σ a m 2 n = 1 N σ t n 2
where N is the number of samples. The channel matrix H between the PU and SU is modeled as a Rician fading channel, that is
H α α + 1 H LOS + 1 α + 1 H NLOS ,
where α denotes the Rician factor, representing the power ratio between the deterministic line-of-sight (LOS) component H LOS and the scattered non-line-of-sight (NLOS) component H NLOS . Each element in H LOS or H NLOS is assumed to follow a standard complex Gaussian distribution, i.e., CN ( 0 , 1 ) . The LOS component is considered quasi-static, while the NLOS component varies randomly over time to reflect realistic multipath fading. In the simulations, α is set to 100.
For comparison, we selected several typical spectrum sensing algorithms as benchmarks, which included the covariance-matrix-aware convolutional neural network (CM-CNN) method [17], noncircular local average variance (NC-LAV) [25], local average variance (LAV) [13], noncircular-based Hadamard (NC-HDM) ratio test [24], Hadamard (HDM) ratio test [12], eigenvalue moment ratio (EMR) [11], and energy detection (ED) [8]. All simulation results were obtained by averaging 60,000 Monte Carlo realizations. There were additional 35,000 training samples for the data-driven methods, including the proposed ACM-CNN and the CM-CNN [17]. The hyperparameters of the augmented covariance matrix based CNN in our simulations are given in Table 1. The simulations were conducted on a personal computer equipped with an Intel Core i7-13800H CPU (Intel Corporation, Santa Clara, CA, USA) and an NVIDIA RTX 2000 Ada Generation Laptop GPU (NVIDIA Corporation, Santa Clara, CA, USA). It should be noted that the online detection time per sample was approximately 0.0398 seconds by averaging 1000 trials, thereby supporting applicability to real-time detection in practical scenarios.

4.1. ROC Detection Performance Comparison

First, we evaluate the detection performance of the proposed method by plotting receiver operating characteristic (ROC) curves, which illustrate the probability of detection versus the probability of false alarm. Three sets of experiments were conducted: (i) i.i.d. noise; (ii) varying the noise variance in antennas ( ε a 0 ) while the keeping noise variance fixed in time ( ε t = 0 ); and (iii) varying the noise variance in time ( ε t 0 ) while keeping the noise variance in antennas fixed ( ε a = 0 ). For each case, we evaluated the detection performance under different numbers of observed samples N. In this case, the SNR was fixed at 18 dB .
Figure 4 and Figure 5 show the ROC curves of the different methods under i.i.d. noise with a low sample size ( N = 40 ) and a high sample size ( N = 360 ), respectively. It can be observed that our method consistently outperformed all other methods, regardless of the sample size. Specifically, in Figure 4, our ACM-CNN method achieved a detection probability close to 50% under the probability of false alarm P f = 0.1 , which was more than 15 percentage points higher than both CM-CNN and ED. The remaining methods almost failed under such a low-sample environment. In Figure 5, all methods were able to detect under the high-sample environment; however, our method still achieved the best detection performance. It is worth noting that the ED method benefits from prior knowledge of the averaging noise power. Except for ED, all other methods operate without any prior information, i.e., totally blind detection methods. Among these totally-blind detection methods, it is seen that the data-driven approaches outperformed the model-driven ones. Furthermore, we see that the methods that exploit noncircularity demonstrated superior performance when compared to their counterparts that do not use the noncircularity (e.g., NC-HDM outperformed HDM). In order to verify the effectiveness and convergence of the proposed model during training, we also plot the training loss versus the number of training iterations of the ACM-CNN in Figure 6, where the parameter settings are kept the same as those of Figure 5. It is seen that the loss value gradually decreased as the number of training iterations was increased, and eventually converged to a value close to zero. This demonstrates that the trained model was able to effectively learn discriminative features from the data and converged to a stable training state.
To further understand how the proposed ACM-CNN model extracts discriminative features for spectrum sensing, we visualized the intermediate feature maps of the convolutional layers under hypothesis H 1 . Specifically, the augmented covariance tensor R ̲ with sample size N = 160 was input into the trained model, and a forward pass was performed. The output feature maps of C1 and C2 are normalized and visualized in Figure 7 and Figure 8, respectively. In the figures, “Ch q” denotes the q-th channel of the output feature map.
From the visualizations, it can be observed that the network effectively captured both the circular and noncircular components embedded in R ̲ . Specifically, the two block matrices along the main diagonal encode the conventional covariance structure, which reflects circular signal characteristics (e.g., Ch 9 in Figure 7 and Ch 21 in Figure 8), while the off-diagonal blocks represent the complementary covariance, which arises exclusively in noncircular signals (e.g., Ch 10 in Figure 7 and Ch 20 in Figure 8). These results demonstrate that the proposed ACM-CNN is capable of jointly exploiting both circular and noncircular statistical features, thereby enabling the learning of more discriminative and robust data-driven test statistics for spectrum sensing.
Figure 9 and Figure 10 illustrate the ROC curves under the condition of ε a 0 for N = 40 and N = 360 , respectively. It can be observed that several methods failed in the presence of unstable noise across the antennas (e.g., ED and EMR), while only the data-driven methods (ACM-CNN and CM-CNN) and those based on the Hadamard ratio test (HDM and NC-HDM) remained functional in such scenarios. However, Hadamard-based methods only achieved satisfactory performance under large sample size conditions. In contrast, the data-driven methods not only performed better overall, but also maintained effectiveness even in the low-sample environment.
By comparing Figure 4 and Figure 9, as well as Figure 5 and Figure 10, we can see that ACM-CNN, CM-CNN, HDM, and NC-HDM exhibited some performance degradation under unstable noise across antennas. Nevertheless, the decline was within an acceptable range, indicating that these four methods exhibited a certain degree of robustness to unstable noise. Our method still achieved the best detection performance under all tested conditions.
Figure 11 and Figure 12 illustrate the ROC curves under the condition of ε t 0 for N = 40 and N = 360 , respectively. By comparing Figure 4 and Figure 11, as well as Figure 5 and Figure 12, we can observe that all methods experienced some performance degradation under temporally unstable noise, indicating that they all exhibited a certain degree of robustness to such noise. Compared to the unstable noise across antennas, the adverse impact of temporally unstable noise was relatively smaller. In Figure 12, ACM-CNN achieved a detection probability exceeding 96% at a false alarm rate P f = 0.1 , significantly outperforming all other methods.

4.2. Probability of Detection Versus the Number of Observations and SNR

Figure 13 shows how the detection probability of the respective algorithms changed with the number of samples N when the probability of false alarm was fixed at 0.1. It can be seen that under an i.i.d. noise environment, the detection performance of all algorithms improved as the number of samples N increased. Our ACM-CNN algorithm was the best among all algorithms for all sample numbers N.
Figure 14 shows a curve of the detection probability changing with SNR under an i.i.d. noise environment with fixed P f = 0.1 . It can be seen that, under all SNR conditions, our proposed ACM-CNN algorithm was optimal.
Figure 13 illustrates the probability of detection versus number of samples N for the various detection algorithms under an i.i.d. noise environment, with the probability of false alarm fixed at 0.1. The results demonstrate that as N increased, all methods achieved a progressively better detection performance, which is expected, since more samples provide richer statistical information for signal detection. Among all the evaluated algorithms, our proposed ACM-CNN significantly outperformed the other methods across the entire range of sample numbers. In particular, ACM-CNN exhibited a steeper performance gain with increasing N, reaching a detection probability of more than 90% at a number of samples about 175. Model-driven approaches like LAV and HDM performed substantially worse, showing limited improvement with an increasing number of samples, which highlights their insufficiency for leveraging high-dimensional data patterns compared to deep-learning-based methods.
Figure 14 shows the probability of detection versus SNR under an i.i.d. noise assumption and fixed false alarm rate ( P f = 0.1 ). The results clearly indicate that ACM-CNN consistently achieved the highest detection probability at every SNR level. Especially in the low-SNR regime (e.g., SNR < −20 dB), ACM-CNN exhibited a remarkable performance, whereas the other methods failed to maintain effective performance. As the SNR improved, all algorithms began to benefit, but the performance gap between ACM-CNN and the rest remained evident, underscoring its superior capacity for feature extraction and classification.

4.3. Generalizability

Since the proposed ACM-CNN method is data-driven, the deployed neural network model was trained offline based on the data distribution in the training set. However, during online detection, the noise model, SNR, and other environmental factors may differ from those present in the training phase. Therefore, it is meaningful to investigate the generalizability of the proposed method under conditions mismatched between training and testing. Specifically, we evaluate the generalization performance of ACM-CNN by presenting its ROC curves under three scenarios: mismatched SNRs, different degrees of antenna noise uncertainty, and different degrees of time noise uncertainty between training and testing, respectively.
Figure 15 illustrates the ROC curves of the proposed ACM-CNN method under SNR conditions mismatched between training and detection. Specifically, “ACM-CNN ( p dB / q dB )” denotes a model trained on a dataset with SNR = p dB and evaluated on a test dataset with SNR = q dB. As observed in the figure, the detection performance remained nearly identical across models trained at different SNR levels when evaluated on the same test dataset. This indicates that our method successfully extracted signal-relevant information from the sample covariance matrix and was largely unaffected by variations in SNR. Consequently, ACM-CNN demonstrated strong generalizability and robustness to SNR mismatch between training and detection.
Figure 16 illustrates the ROC curves of the proposed ACM-CNN method with different degrees of antenna noise uncertainty between training and detection. Specifically, “ACM-CNN ( v a dB / w a dB )” denotes a model trained on a dataset with ε a = v a dB and evaluated on a test dataset with ε a = w a dB. As observed in the figure, the neural network model trained under an antenna noise uncertainty of ε a = 5 dB performed slightly worse than the model trained with ε a = 0 dB when tested on a dataset with ideal uniform noise ( ε a = 0 dB). However, when evaluated on test sets with nonzero antenna noise uncertainty ( ε a 0 dB), the ε a = 5 dB-trained model outperformed its counterparts trained under ideal conditions. This phenomenon indicates that, while the presence of unstable noise across antennas during training introduces interference that slightly degrades peak detection performance, it simultaneously enhances the robustness to noise uncertainty. Consequently, the model trained with an antenna noise uncertainty of ε a 0 dB exhibited slower performance degradation under mismatched antenna noise conditions, demonstrating superior generalization capability to inter-antenna noise variations.
Figure 17 illustrates the ROC curves of the proposed ACM-CNN method with different degrees of time noise uncertainty between training and detection. Specifically, “ACM-CNN ( v t dB / w t dB )” denotes a model trained on a dataset with ε t = v t dB and evaluated on a test dataset with ε t = w t dB. Unlike the significant impact of unstable noise across antennas on model training, unstable noise across time had a much smaller effect on the training outcome and evaluation result. This is primarily because, prior to being fed into the neural network, the input data undergo covariance matrix computation, during which temporal variations are effectively averaged out. As a result, the influence of temporal noise uncertainty is substantially mitigated. These findings demonstrate that the proposed ACM-CNN method exhibits strong robustness and generalization capabilities in the presence of temporal unstable noise.

4.4. Probability of Detection Versus Noncircularity

Similarly to existing non-circular signal-based methods, our proposed ACM-CNN leverages both the circular and noncircular components inherently present in such signals. In the special case of circular signals, where the noncircular component is zero, noncircular-signal-based methods naturally degenerate into their circular counterparts. To assess how different levels of noncircularity rate κ affect the performance of ACM-CNN, we present the detection probabilities of various algorithms as a function of κ , as illustrated in Figure 18. It can be observed that the performance of the three algorithms (ACM-CNN, NC-LAV, and NC-HDM) that exploit noncircular information improved significantly as κ increased, whereas those that do not utilize noncircular features remained unaffected by changes in κ . When the noncircularity rate κ approached zero, the performance of ACM-CNN closely aligned with that of CM-CNN. This demonstrates that ACM-CNN can gracefully reduce to a circular-signal-based model in the absence of noncircularity, while effectively leveraging additional structure when noncircularity is present, thus validating its adaptability and effectiveness for noncircular signals.

5. Conclusions

In this work, we have discussed the problem of spectrum sensing in multi-antenna cognitive radio networks by emphasizing the importance of non-circular signal characteristics. We proposed an augmented covariance-matrix-aware convolutional neural network (ACM-CNN) that integrates both conventional covariance and complementary covariance matrices into a unified learning framework. This design allows the model to fully exploit the second-order statistical features unique to non-circular signals, which are typically neglected in conventional spectrum sensing methods. Simulation results show that ACM-CNN significantly outperformed both traditional model-driven algorithms and CNN-based approaches in non-circular signal scenarios.

Author Contributions

Methodology, S.C.; Validation, W.S.; Investigation, W.S.; Writing—original draft, S.C.; Writing—review & editing, Z.H. and G.S.; Supervision, Z.H. All authors have read and agreed to the published version of this manuscript.

Funding

This research was funded by the National Natural Science Foundation of China under grants 62201371 and 62302082, and by the Fundamental Research Funds for the Central Universities under grant YJ202305.

Institutional Review Board Statement

Not applicable.

Informed Consent Statement

Not applicable.

Data Availability Statement

Data are contained within the article.

Conflicts of Interest

The authors declare no conflicts of interest.

References

  1. Ali, A.; Hamouda, W. Advances on spectrum sensing for cognitive radio networks: Theory and applications. IEEE Commun. Surv. Tutorials 2016, 19, 1277–1304. [Google Scholar] [CrossRef]
  2. Mitola, J.; Maguire, G.Q. Cognitive radio: Making software radios more personal. Pers. Commun. 1999, 6, 13–18. [Google Scholar] [CrossRef]
  3. Yucek, T.; Arslan, H. A survey of spectrum sensing algorithms for cognitive radio applications. IEEE Commun. Surv. Tutor. 2009, 11, 116–130. [Google Scholar] [CrossRef]
  4. Axell, E.; Leus, G.; Larsson, E.G.; Poor, H.V. Spectrum Sensing for Cognitive Radio: State-of-the-Art and Recent Advances. IEEE Signal Process. Mag. 2012, 29, 101–116. [Google Scholar] [CrossRef]
  5. Haykin, S.; Thomson, D.J.; Reed, J.H. Spectrum sensing for cognitive radio. Proc. IEEE 2009, 97, 849–877. [Google Scholar] [CrossRef]
  6. Cao, X.; Yang, B.; Wang, K.; Li, X.; Yu, Z.; Yuen, C.; Zhang, Y.; Han, Z. AI-Empowered Multiple Access for 6G: A Survey of Spectrum Sensing, Protocol Designs, and Optimizations. Proc. IEEE 2024, 112, 1264–1302. [Google Scholar] [CrossRef]
  7. Ngo, Q.T.; Jayawickrama, B.A.; He, Y.; Dutkiewicz, E.; Weththasinghe, K.; Clark, N.; Arbon, E.; Bowyer, M. Optimizing Spectrum Sensing in Cognitive GEO-LEO Satellite Networks: Overcoming Challenges for Effective Spectrum Utilization. IEEE Veh. Technol. Mag. 2025, 2–11. [Google Scholar] [CrossRef]
  8. Digham, F.F.; Alouini, M.S.; Simon, M.K. On the Energy Detection of Unknown Signals Over Fading Channels. IEEE Trans. Commun. 2007, 55, 21–24. [Google Scholar] [CrossRef]
  9. Zeng, Y.; Koh, C.L.; Liang, Y.C. Maximum eigenvalue detection: Theory and application. In Proceedings of the IEEE International Conference on Communications (ICC), Beijing, China, 19–23 May 2008; IEEE: Piscataway, NJ, USA, 2008; pp. 4160–4164. [Google Scholar]
  10. Chen, A.Z.; Shi, Z.P.; Liang, G.; Sun, G. Robust spectrum sensing based on correlation for cognitive radio networks with uncalibrated multiple antennas. IEEE Commun. Lett. 2020, 25, 1665–1668. [Google Scholar] [CrossRef]
  11. Huang, L.; Fang, J.; Liu, K.; So, H.C.; Li, H. An eigenvalue-moment-ratio approach to blind spectrum sensing for cognitive radio under sample-starving environment. IEEE Trans. Veh. Technol. 2014, 64, 3465–3480. [Google Scholar] [CrossRef]
  12. Ramírez, D.; Vazquez-Vilar, G.; López-Valcarce, R.; Vía, J.; Santamaría, I. Detection of rank-P signals in cognitive radio networks with uncalibrated multiple antennas. IEEE Trans. Signal Process. 2011, 59, 3764–3774. [Google Scholar] [CrossRef]
  13. Jin, M.; Guo, Q.; Li, Y.; Xi, J.; Wang, G.; Huang, D. Blind cooperative parametric spectrum sensing with distributed sensors using local average power passing. IEEE Trans. Veh. Technol. 2016, 65, 9703–9714. [Google Scholar] [CrossRef]
  14. LeCun, Y.; Bengio, Y.; Hinton, G. Deep learning. Nature 2015, 521, 436–444. [Google Scholar] [CrossRef]
  15. Hinton, G.E.; Osindero, S.; Teh, Y.W. A fast learning algorithm for deep belief nets. Neural Comput. 2006, 18, 1527–1554. [Google Scholar] [CrossRef]
  16. LeCun, Y.; Bottou, L.; Bengio, Y.; Haffner, P. Gradient-based learning applied to document recognition. Proc. IEEE 2002, 86, 2278–2324. [Google Scholar] [CrossRef]
  17. Liu, C.; Wang, J.; Liu, X.; Liang, Y.C. Deep CM-CNN for spectrum sensing in cognitive radio. IEEE J. Sel. Areas Commun. 2019, 37, 2306–2321. [Google Scholar] [CrossRef]
  18. Gao, J.; Yi, X.; Zhong, C.; Chen, X.; Zhang, Z. Deep learning for spectrum sensing. IEEE Wirel. Commun. Lett. 2019, 8, 1727–1730. [Google Scholar] [CrossRef]
  19. Xie, J.; Liu, C.; Liang, Y.C.; Fang, J. Activity pattern aware spectrum sensing: A CNN-based deep learning approach. IEEE Commun. Lett. 2019, 23, 1025–1028. [Google Scholar] [CrossRef]
  20. Xie, J.; Fang, J.; Liu, C.; Li, X. Deep learning-based spectrum sensing in cognitive radio: A CNN-LSTM approach. IEEE Commun. Lett. 2020, 24, 2196–2200. [Google Scholar] [CrossRef]
  21. Chen, Z.; Xu, Y.Q.; Wang, H.; Guo, D. Deep STFT-CNN for spectrum sensing in cognitive radio. IEEE Commun. Lett. 2020, 25, 864–868. [Google Scholar] [CrossRef]
  22. Fang, X.; Jin, M.; Guo, Q.; Jiang, T. CNN-Transformer-based cooperative spectrum sensing in cognitive radio networks. IEEE Wirel. Commun. Lett. 2025, 14, 1576–1580. [Google Scholar] [CrossRef]
  23. Bai, W.; Zheng, G.; Mu, Y.; Ma, H.; Han, Z.; Xue, Y. Cooperative spectrum sensing method based on channel attention and parallel CNN-LSTM. Digit. Signal Process. 2025, 158, 104963. [Google Scholar] [CrossRef]
  24. Huang, L.; Xiao, Y.H.; Zhang, Q. Robust spectrum sensing for noncircular signal in multiantenna cognitive receivers. IEEE Trans. Signal Process. 2014, 63, 498–511. [Google Scholar] [CrossRef]
  25. Chen, A.Z.; Shi, Z.P.; Sun, H.; He, Z.Q.; Bu, F.; Yang, D. A low-complexity spectrum sensing method for noncircular signal in cognitive radio networks with multiple receive antennas. IEEE Commun. Lett. 2019, 23, 1190–1193. [Google Scholar] [CrossRef]
  26. Chen, A.Z.; Shi, Z.P. Covariance-based spectrum sensing for noncircular signal in cognitive radio networks with uncalibrated multiple antennas. IEEE Wirel. Commun. Lett. 2020, 9, 662–665. [Google Scholar] [CrossRef]
  27. Kingma, D.P.; Ba, J. Adam: A method for stochastic optimization. arXiv 2014, arXiv:1412.6980. [Google Scholar]
Figure 1. ACM-CNN-based detection framework for spectrum sensing of noncircular signals.
Figure 1. ACM-CNN-based detection framework for spectrum sensing of noncircular signals.
Sensors 25 04791 g001
Figure 2. Heatmap comparisons of augmented covariance matrix: (a) real part of R ^ ̲ under H 1 , (b) real part of R ^ ̲ under H 0 , (c) imaginary part of R ^ ̲ under H 1 , (d) imaginary part of R ^ ̲ under H 0 .
Figure 2. Heatmap comparisons of augmented covariance matrix: (a) real part of R ^ ̲ under H 1 , (b) real part of R ^ ̲ under H 0 , (c) imaginary part of R ^ ̲ under H 1 , (d) imaginary part of R ^ ̲ under H 0 .
Sensors 25 04791 g002
Figure 3. Proposed CNN structure for spectrum sensing of noncircular signals.
Figure 3. Proposed CNN structure for spectrum sensing of noncircular signals.
Sensors 25 04791 g003
Figure 4. ROC curves of different algorithms: N = 40 , SNR = 18 dB, ε a = 0 dB, ε t = 0 dB.
Figure 4. ROC curves of different algorithms: N = 40 , SNR = 18 dB, ε a = 0 dB, ε t = 0 dB.
Sensors 25 04791 g004
Figure 5. ROC curves of different algorithms: N = 360 , SNR = 18 dB, ε a = 0 dB, ε t = 0 dB.
Figure 5. ROC curves of different algorithms: N = 360 , SNR = 18 dB, ε a = 0 dB, ε t = 0 dB.
Sensors 25 04791 g005
Figure 6. Training loss function value versus the number of training iterations.
Figure 6. Training loss function value versus the number of training iterations.
Sensors 25 04791 g006
Figure 7. Visualization of the feature maps in C1 layers.
Figure 7. Visualization of the feature maps in C1 layers.
Sensors 25 04791 g007
Figure 8. Visualization of the feature maps in C2 layers.
Figure 8. Visualization of the feature maps in C2 layers.
Sensors 25 04791 g008
Figure 9. ROC curves of different algorithms: N = 40 , SNR = 18 dB, ε a = 5 dB, and ε t = 0 dB.
Figure 9. ROC curves of different algorithms: N = 40 , SNR = 18 dB, ε a = 5 dB, and ε t = 0 dB.
Sensors 25 04791 g009
Figure 10. ROC curves of different algorithms: N = 360 , SNR = 18 dB, ε a = 5 dB, and ε t = 0 dB.
Figure 10. ROC curves of different algorithms: N = 360 , SNR = 18 dB, ε a = 5 dB, and ε t = 0 dB.
Sensors 25 04791 g010
Figure 11. ROC curves of different algorithms: N = 40 , SNR = 18 dB, ε a = 0 dB, ε t = 5 dB.
Figure 11. ROC curves of different algorithms: N = 40 , SNR = 18 dB, ε a = 0 dB, ε t = 5 dB.
Sensors 25 04791 g011
Figure 12. ROC curves of different algorithms: N = 360 , SNR = 18 dB, ε a = 0 dB, ε t = 5 dB.
Figure 12. ROC curves of different algorithms: N = 360 , SNR = 18 dB, ε a = 0 dB, ε t = 5 dB.
Sensors 25 04791 g012
Figure 13. Detection probability versus the number of samples under P f = 0.1 , SNR = 18 dB, ε a = 0 dB, ε t = 0 dB.
Figure 13. Detection probability versus the number of samples under P f = 0.1 , SNR = 18 dB, ε a = 0 dB, ε t = 0 dB.
Sensors 25 04791 g013
Figure 14. Detection probability versus SNR under P f = 0.1 , N = 160 , ε a = 0 dB, ε t = 0 dB.
Figure 14. Detection probability versus SNR under P f = 0.1 , N = 160 , ε a = 0 dB, ε t = 0 dB.
Sensors 25 04791 g014
Figure 15. ROC curves with mismatched SNRs between training and detection under N = 160 , ε a = 0 dB, ε t = 0 dB.
Figure 15. ROC curves with mismatched SNRs between training and detection under N = 160 , ε a = 0 dB, ε t = 0 dB.
Sensors 25 04791 g015
Figure 16. ROC curves with different degrees of antenna noise uncertainty between training and detection under N = 160 , SNR = 18 dB.
Figure 16. ROC curves with different degrees of antenna noise uncertainty between training and detection under N = 160 , SNR = 18 dB.
Sensors 25 04791 g016
Figure 17. ROC curves with different types of noise uncertainty across time between training and detection under N = 160 , SNR = 18 dB.
Figure 17. ROC curves with different types of noise uncertainty across time between training and detection under N = 160 , SNR = 18 dB.
Sensors 25 04791 g017
Figure 18. Detection probability versus noncircularity κ under P f = 0.1 , N = 160 , ε a = 0 dB, ε t = 0 dB.
Figure 18. Detection probability versus noncircularity κ under P f = 0.1 , N = 160 , ε a = 0 dB, ε t = 0 dB.
Sensors 25 04791 g018
Table 1. Hyperparameters of the augmented covariance-matrix-based CNN.
Table 1. Hyperparameters of the augmented covariance-matrix-based CNN.
Input: Augmented covariance matrix array ( 16 × 16 × 2 )
LayersSize
C 1 + ReLu 20 @ ( 3 × 3 )
C 2 + ReLu 50 @ ( 3 × 3 )
F 1 + ReLu 500 × 3200
F 2 + Softmax 2 × 500
Output: Score Vector ( 2 × 1 )
Disclaimer/Publisher’s Note: The statements, opinions and data contained in all publications are solely those of the individual author(s) and contributor(s) and not of MDPI and/or the editor(s). MDPI and/or the editor(s) disclaim responsibility for any injury to people or property resulting from any ideas, methods, instructions or products referred to in the content.

Share and Cite

MDPI and ACS Style

Chen, S.; He, Z.; Song, W.; Sun, G. Spectrum Sensing for Noncircular Signals Using Augmented Covariance-Matrix-Aware Deep Convolutional Neural Network. Sensors 2025, 25, 4791. https://doi.org/10.3390/s25154791

AMA Style

Chen S, He Z, Song W, Sun G. Spectrum Sensing for Noncircular Signals Using Augmented Covariance-Matrix-Aware Deep Convolutional Neural Network. Sensors. 2025; 25(15):4791. https://doi.org/10.3390/s25154791

Chicago/Turabian Style

Chen, Songlin, Zhenqing He, Wenze Song, and Guohao Sun. 2025. "Spectrum Sensing for Noncircular Signals Using Augmented Covariance-Matrix-Aware Deep Convolutional Neural Network" Sensors 25, no. 15: 4791. https://doi.org/10.3390/s25154791

APA Style

Chen, S., He, Z., Song, W., & Sun, G. (2025). Spectrum Sensing for Noncircular Signals Using Augmented Covariance-Matrix-Aware Deep Convolutional Neural Network. Sensors, 25(15), 4791. https://doi.org/10.3390/s25154791

Note that from the first issue of 2016, this journal uses article numbers instead of page numbers. See further details here.

Article Metrics

Back to TopTop