Commit a1da6236 authored by robert's avatar robert

Init

parent 46a37329
...@@ -64,103 +64,40 @@ __attribute__((always_inline)) inline c16_t c32x16cumulVectVectWithSteps(c16_t * ...@@ -64,103 +64,40 @@ __attribute__((always_inline)) inline c16_t c32x16cumulVectVectWithSteps(c16_t *
return c16x32div(cumul, N); return c16x32div(cumul, N);
} }
int nr_pusch_channel_estimation(PHY_VARS_gNB *gNB,
unsigned char Ns,
int nl,
unsigned short p,
unsigned char symbol,
int ul_id,
unsigned short bwp_start_subcarrier,
nfapi_nr_pusch_pdu_t *pusch_pdu,
int *max_ch,
uint32_t *nvar)
{
c16_t pilot[3280] __attribute__((aligned(32)));
const int chest_freq = gNB->chest_freq;
#ifdef DEBUG_CH
FILE *debug_ch_est;
debug_ch_est = fopen("debug_ch_est.txt","w");
#endif
NR_gNB_PUSCH *pusch_vars = &gNB->pusch_vars[ul_id];
c16_t **ul_ch_estimates = (c16_t **)pusch_vars->ul_ch_estimates;
const int symbolSize = gNB->frame_parms.ofdm_symbol_size;
const int soffset = (Ns & 3) * gNB->frame_parms.symbols_per_slot*symbolSize;
const int nushift = (p >> 1) & 1;
int ch_offset = symbolSize*symbol;
const int symbol_offset = symbolSize*symbol;
const int k0 = bwp_start_subcarrier;
const int nb_rb_pusch = pusch_pdu->rb_size;
LOG_D(PHY, "ch_offset %d, soffset %d, symbol_offset %d, OFDM size %d, Ns = %d, k0 = %d, symbol %d\n",
ch_offset, soffset,
symbol_offset,
symbolSize,
Ns,
k0,
symbol);
//------------------generate DMRS------------------//
if(pusch_pdu->ul_dmrs_scrambling_id != gNB->pusch_gold_init[pusch_pdu->scid]) {
gNB->pusch_gold_init[pusch_pdu->scid] = pusch_pdu->ul_dmrs_scrambling_id;
nr_gold_pusch(gNB, pusch_pdu->scid, pusch_pdu->ul_dmrs_scrambling_id);
}
if (pusch_pdu->transform_precoding == transformPrecoder_disabled) { int inner_channel_estimation (
// Note: pilot returned by the following function is already the complex conjugate of the transmitted DMRS PHY_VARS_gNB *gNB
nr_pusch_dmrs_rx(gNB, , int aarx
Ns, , const int symbol_offset
gNB->nr_gold_pusch_dmrs[pusch_pdu->scid][Ns][symbol], , c16_t **ul_ch_estimates
pilot, , int nl
(1000 + p), , int ch_offset
0, , const int symbolSize
nb_rb_pusch, , nfapi_nr_pusch_pdu_t *pusch_pdu
(pusch_pdu->bwp_start + pusch_pdu->rb_start) * NR_NB_SC_PER_RB, , const int chest_freq
pusch_pdu->dmrs_config_type); , c16_t pilot[3280] // __attribute__((aligned(32)))
} else { // if transform precoding or SC-FDMA is enabled in Uplink , const int k0
// NR_SC_FDMA supports type1 DMRS so only 6 DMRS REs per RB possible , const int nb_rb_pusch
const int index = get_index_for_dmrs_lowpapr_seq(nb_rb_pusch * (NR_NB_SC_PER_RB / 2)); , unsigned short p
const uint8_t u = pusch_pdu->dfts_ofdm.low_papr_group_number; , const int soffset
const uint8_t v = pusch_pdu->dfts_ofdm.low_papr_sequence_number; , int *max_ch
c16_t *dmrs_seq = gNB_dmrs_lowpaprtype1_sequence[u][v][index]; , c16_t ul_ls_est[symbolSize]
LOG_D(PHY,"Transform Precoding params. u: %d, v: %d, index for dmrsseq: %d\n", u, v, index); , NR_gNB_PUSCH *pusch_vars
AssertFatal(index >= 0, "Num RBs not configured according to 3GPP 38.211 section 6.3.1.4. For PUSCH with transform precoding, num RBs cannot be multiple of any other primenumber other than 2,3,5\n"); , delay_t *delay
AssertFatal(dmrs_seq != NULL, "DMRS low PAPR seq not found, check if DMRS sequences are generated"); , uint64_t noise_amp2
nr_pusch_lowpaprtype1_dmrs_rx(gNB, Ns, dmrs_seq, pilot, 1000, 0, nb_rb_pusch, 0, pusch_pdu->dmrs_config_type); , int nest_count
#ifdef DEBUG_PUSCH , const int nushift
printf ("NR_UL_CHANNEL_EST: index %d, u %d,v %d\n", index, u, v); ) {
LOG_M("gNb_DMRS_SEQ.m","gNb_DMRS_SEQ", dmrs_seq,6*nb_rb_pusch,1,1);
#endif
}
//------------------------------------------------//
#ifdef DEBUG_PUSCH
for (int i = 0; i < (6 * nb_rb_pusch); i++) {
LOG_I(PHY, "In %s: %d + j*(%d)\n", __FUNCTION__, pilot[i].r,pilot[i].i);
}
#endif
int nest_count = 0;
uint64_t noise_amp2 = 0;
c16_t ul_ls_est[symbolSize] __attribute__((aligned(32)));
memset(ul_ls_est, 0, sizeof(c16_t) * symbolSize);
delay_t *delay = &gNB->ulsch[ul_id].delay;
memset(delay, 0, sizeof(*delay));
for (int aarx=0; aarx<gNB->frame_parms.nb_antennas_rx; aarx++) {
c16_t *rxdataF = (c16_t *)&gNB->common_vars.rxdataF[aarx][symbol_offset]; c16_t *rxdataF = (c16_t *)&gNB->common_vars.rxdataF[aarx][symbol_offset];
c16_t *ul_ch = &ul_ch_estimates[nl * gNB->frame_parms.nb_antennas_rx + aarx][ch_offset]; c16_t *ul_ch = &ul_ch_estimates[nl * gNB->frame_parms.nb_antennas_rx + aarx][ch_offset];
memset(ul_ch,0,sizeof(*ul_ch)*symbolSize); memset(ul_ch,0,sizeof(*ul_ch)*symbolSize);
#ifdef DEBUG_PUSCH #ifdef DEBUG_PUSCH
LOG_I(PHY, "In %s symbol_offset %d, nushift %d\n", __FUNCTION__, symbol_offset, nushift); LOG_I(PHY, "In %s symbol_offset %d, nushift %d\n", __FUNCTION__, symbol_offset, nushift);
LOG_I(PHY, "In %s ch est pilot, N_RB_UL %d\n", __FUNCTION__, gNB->frame_parms.N_RB_UL); LOG_I(PHY, "In %s ch est pilot, N_RB_UL %d\n", __FUNCTION__, gNB->frame_parms.N_RB_UL);
LOG_I(PHY, "In %s bwp_start_subcarrier %d, k0 %d, first_carrier %d, nb_rb_pusch %d\n", __FUNCTION__, bwp_start_subcarrier, k0, gNB->frame_parms.first_carrier_offset, nb_rb_pusch); LOG_I(PHY, "In %s bwp_start_subcarrier %d, k0 %d, first_carrier %d, nb_rb_pusch %d\n", __FUNCTION__, bwp_start_subcarrier, k0, gNB->frame_parms.first_carrier_offset, nb_rb_pusch);
LOG_I(PHY, "In %s ul_ch addr %p nushift %d\n", __FUNCTION__, ul_ch, nushift); LOG_I(PHY, "In %s ul_ch addr %p nushift %d\n", __FUNCTION__, ul_ch, nushift);
#endif #endif
if (pusch_pdu->dmrs_config_type == pusch_dmrs_type1 && chest_freq == 0) { if (pusch_pdu->dmrs_config_type == pusch_dmrs_type1 && chest_freq == 0) {
c16_t *pil = pilot; c16_t *pil = pilot;
...@@ -193,9 +130,9 @@ int nr_pusch_channel_estimation(PHY_VARS_gNB *gNB, ...@@ -193,9 +130,9 @@ int nr_pusch_channel_estimation(PHY_VARS_gNB *gNB,
int delay_idx = get_delay_idx(delay->est_delay, MAX_DELAY_COMP); int delay_idx = get_delay_idx(delay->est_delay, MAX_DELAY_COMP);
c16_t *ul_delay_table = gNB->frame_parms.delay_table[delay_idx]; c16_t *ul_delay_table = gNB->frame_parms.delay_table[delay_idx];
#ifdef DEBUG_PUSCH #ifdef DEBUG_PUSCH
printf("Estimated delay = %i\n", delay->est_delay >> 1); printf("Estimated delay = %i\n", delay->est_delay >> 1);
#endif #endif
pilot_cnt = 0; pilot_cnt = 0;
for (int n = 0; n < 3*nb_rb_pusch; n++) { for (int n = 0; n < 3*nb_rb_pusch; n++) {
...@@ -207,12 +144,12 @@ int nr_pusch_channel_estimation(PHY_VARS_gNB *gNB, ...@@ -207,12 +144,12 @@ int nr_pusch_channel_estimation(PHY_VARS_gNB *gNB,
int k = pilot_cnt << 1; int k = pilot_cnt << 1;
c16_t ch16 = c16mulShift(ul_ls_est[k], ul_delay_table[k], 8); c16_t ch16 = c16mulShift(ul_ls_est[k], ul_delay_table[k], 8);
#ifdef DEBUG_PUSCH #ifdef DEBUG_PUSCH
re_offset = (k0 + (n << 2) + (k_line << 1)) % symbolSize; re_offset = (k0 + (n << 2) + (k_line << 1)) % symbolSize;
c16_t *rxF = &rxdataF[soffset + re_offset]; c16_t *rxF = &rxdataF[soffset + re_offset];
printf("pilot %4d: pil -> (%6d,%6d), rxF -> (%4d,%4d), ch -> (%4d,%4d)\n", printf("pilot %4d: pil -> (%6d,%6d), rxF -> (%4d,%4d), ch -> (%4d,%4d)\n",
pilot_cnt, pil->r, pil->i, rxF->r, rxF->i, ch.r, ch.i); pilot_cnt, pil->r, pil->i, rxF->r, rxF->i, ch.r, ch.i);
#endif #endif
if (pilot_cnt == 0) { if (pilot_cnt == 0) {
c16multaddVectRealComplex(filt16_ul_p0, &ch16, ul_ch, 16); c16multaddVectRealComplex(filt16_ul_p0, &ch16, ul_ch, 16);
...@@ -244,11 +181,11 @@ int nr_pusch_channel_estimation(PHY_VARS_gNB *gNB, ...@@ -244,11 +181,11 @@ int nr_pusch_channel_estimation(PHY_VARS_gNB *gNB,
noise_amp2 += c16amp2(c16sub(ul_ls_est[k], ul_ch[k])); noise_amp2 += c16amp2(c16sub(ul_ls_est[k], ul_ch[k]));
noise_amp2 += c16amp2(c16sub(ul_ls_est[k + 1], ul_ch[k + 1])); noise_amp2 += c16amp2(c16sub(ul_ls_est[k + 1], ul_ch[k + 1]));
#ifdef DEBUG_PUSCH #ifdef DEBUG_PUSCH
re_offset = (k0 + (n << 2) + (k_line << 1)) % symbolSize; re_offset = (k0 + (n << 2) + (k_line << 1)) % symbolSize;
c16_t *rxF = &rxdataF[soffset + re_offset]; c16_t *rxF = &rxdataF[soffset + re_offset];
printf("ch -> (%4d,%4d), ch_inter -> (%4d,%4d)\n", ul_ls_est[k].r, ul_ls_est[k].i, ul_ch[k].r, ul_ch[k].i); printf("ch -> (%4d,%4d), ch_inter -> (%4d,%4d)\n", ul_ls_est[k].r, ul_ls_est[k].i, ul_ch[k].r, ul_ch[k].i);
#endif #endif
pilot_cnt++; pilot_cnt++;
nest_count += 2; nest_count += 2;
} }
...@@ -292,26 +229,26 @@ int nr_pusch_channel_estimation(PHY_VARS_gNB *gNB, ...@@ -292,26 +229,26 @@ int nr_pusch_channel_estimation(PHY_VARS_gNB *gNB,
// First PRB // First PRB
ch=c32x16cumulVectVectWithSteps(pilot, &pil_offset, 1, rxF, &re_offset, 2, symbolSize, 6); ch=c32x16cumulVectVectWithSteps(pilot, &pil_offset, 1, rxF, &re_offset, 2, symbolSize, 6);
#if NO_INTERP #if NO_INTERP
for (c16_t *end=ul_ch+12; ul_ch<end; ul_ch++) for (c16_t *end=ul_ch+12; ul_ch<end; ul_ch++)
*ul_ch=ch; *ul_ch=ch;
#else #else
c16multaddVectRealComplex(filt8_avlip0, &ch, ul_ch, 8); c16multaddVectRealComplex(filt8_avlip0, &ch, ul_ch, 8);
ul_ch += 8; ul_ch += 8;
c16multaddVectRealComplex(filt8_avlip1, &ch, ul_ch, 8); c16multaddVectRealComplex(filt8_avlip1, &ch, ul_ch, 8);
ul_ch += 8; ul_ch += 8;
c16multaddVectRealComplex(filt8_avlip2, &ch, ul_ch, 8); c16multaddVectRealComplex(filt8_avlip2, &ch, ul_ch, 8);
ul_ch -= 12; ul_ch -= 12;
#endif #endif
for (int pilot_cnt=6; pilot_cnt<6*(nb_rb_pusch-1); pilot_cnt += 6) { for (int pilot_cnt=6; pilot_cnt<6*(nb_rb_pusch-1); pilot_cnt += 6) {
ch=c32x16cumulVectVectWithSteps(pilot, &pil_offset, 1, rxF, &re_offset, 2, symbolSize, 6); ch=c32x16cumulVectVectWithSteps(pilot, &pil_offset, 1, rxF, &re_offset, 2, symbolSize, 6);
*max_ch = max(*max_ch, max(abs(ch.r), abs(ch.i))); *max_ch = max(*max_ch, max(abs(ch.r), abs(ch.i)));
#if NO_INTERP #if NO_INTERP
for (c16_t *end=ul_ch+12; ul_ch<end; ul_ch++) for (c16_t *end=ul_ch+12; ul_ch<end; ul_ch++)
*ul_ch=ch; *ul_ch=ch;
#else #else
ul_ch[3].r += (ch.r * 1365)>>15; // 1/12*16384 ul_ch[3].r += (ch.r * 1365)>>15; // 1/12*16384
ul_ch[3].i += (ch.i * 1365)>>15; // 1/12*16384 ul_ch[3].i += (ch.i * 1365)>>15; // 1/12*16384
...@@ -322,15 +259,15 @@ int nr_pusch_channel_estimation(PHY_VARS_gNB *gNB, ...@@ -322,15 +259,15 @@ int nr_pusch_channel_estimation(PHY_VARS_gNB *gNB,
ul_ch += 8; ul_ch += 8;
c16multaddVectRealComplex(filt8_avlip5, &ch, ul_ch, 8); c16multaddVectRealComplex(filt8_avlip5, &ch, ul_ch, 8);
ul_ch -= 8; ul_ch -= 8;
#endif #endif
} }
// Last PRB // Last PRB
ch=c32x16cumulVectVectWithSteps(pilot, &pil_offset, 1, rxF, &re_offset, 2, symbolSize, 6); ch=c32x16cumulVectVectWithSteps(pilot, &pil_offset, 1, rxF, &re_offset, 2, symbolSize, 6);
#if NO_INTERP #if NO_INTERP
for (c16_t *end=ul_ch+12; ul_ch<end; ul_ch++) for (c16_t *end=ul_ch+12; ul_ch<end; ul_ch++)
*ul_ch=ch; *ul_ch=ch;
#else #else
ul_ch[3].r += (ch.r * 1365)>>15; // 1/12*16384 ul_ch[3].r += (ch.r * 1365)>>15; // 1/12*16384
ul_ch[3].i += (ch.i * 1365)>>15; // 1/12*16384 ul_ch[3].i += (ch.i * 1365)>>15; // 1/12*16384
...@@ -338,7 +275,7 @@ int nr_pusch_channel_estimation(PHY_VARS_gNB *gNB, ...@@ -338,7 +275,7 @@ int nr_pusch_channel_estimation(PHY_VARS_gNB *gNB,
c16multaddVectRealComplex(filt8_avlip3, &ch, ul_ch, 8); c16multaddVectRealComplex(filt8_avlip3, &ch, ul_ch, 8);
ul_ch += 8; ul_ch += 8;
c16multaddVectRealComplex(filt8_avlip6, &ch, ul_ch, 8); c16multaddVectRealComplex(filt8_avlip6, &ch, ul_ch, 8);
#endif #endif
} else { // this is case without frequency-domain linear interpolation, just take average of LS channel estimates of 4 DMRS REs and use a common value for the whole PRB } else { // this is case without frequency-domain linear interpolation, just take average of LS channel estimates of 4 DMRS REs and use a common value for the whole PRB
LOG_D(PHY,"PUSCH estimation DMRS type 2, no Freq-domain interpolation"); LOG_D(PHY,"PUSCH estimation DMRS type 2, no Freq-domain interpolation");
c16_t *pil = pilot; c16_t *pil = pilot;
...@@ -369,17 +306,17 @@ int nr_pusch_channel_estimation(PHY_VARS_gNB *gNB, ...@@ -369,17 +306,17 @@ int nr_pusch_channel_estimation(PHY_VARS_gNB *gNB,
re_offset = (re_offset+5) % symbolSize; re_offset = (re_offset+5) % symbolSize;
c16_t ch=c16x32div(ch0, 4); c16_t ch=c16x32div(ch0, 4);
#if NO_INTERP #if NO_INTERP
for (c16_t *end=ul_ch+12; ul_ch<end; ul_ch++) for (c16_t *end=ul_ch+12; ul_ch<end; ul_ch++)
*ul_ch=ch; *ul_ch=ch;
#else #else
c16multaddVectRealComplex(filt8_avlip0, &ch, ul_ch, 8); c16multaddVectRealComplex(filt8_avlip0, &ch, ul_ch, 8);
ul_ch += 8; ul_ch += 8;
c16multaddVectRealComplex(filt8_avlip1, &ch, ul_ch, 8); c16multaddVectRealComplex(filt8_avlip1, &ch, ul_ch, 8);
ul_ch += 8; ul_ch += 8;
c16multaddVectRealComplex(filt8_avlip2, &ch, ul_ch, 8); c16multaddVectRealComplex(filt8_avlip2, &ch, ul_ch, 8);
ul_ch -= 12; ul_ch -= 12;
#endif #endif
for (int pilot_cnt=4; pilot_cnt<4*(nb_rb_pusch-1); pilot_cnt += 4) { for (int pilot_cnt=4; pilot_cnt<4*(nb_rb_pusch-1); pilot_cnt += 4) {
c32_t ch0; c32_t ch0;
...@@ -402,10 +339,10 @@ int nr_pusch_channel_estimation(PHY_VARS_gNB *gNB, ...@@ -402,10 +339,10 @@ int nr_pusch_channel_estimation(PHY_VARS_gNB *gNB,
ch=c16x32div(ch0, 4); ch=c16x32div(ch0, 4);
*max_ch = max(*max_ch, max(abs(ch.r), abs(ch.i))); *max_ch = max(*max_ch, max(abs(ch.r), abs(ch.i)));
#if NO_INTERP #if NO_INTERP
for (c16_t *end=ul_ch+12; ul_ch<end; ul_ch++) for (c16_t *end=ul_ch+12; ul_ch<end; ul_ch++)
*ul_ch=ch; *ul_ch=ch;
#else #else
ul_ch[3] = c16maddShift(ch, (c16_t){1365, 1365}, (c16_t){0, 0}, 15); // 1365 = 1/12*16384 (full range is +/- 32768) ul_ch[3] = c16maddShift(ch, (c16_t){1365, 1365}, (c16_t){0, 0}, 15); // 1365 = 1/12*16384 (full range is +/- 32768)
ul_ch += 4; ul_ch += 4;
c16multaddVectRealComplex(filt8_avlip3, &ch, ul_ch, 8); c16multaddVectRealComplex(filt8_avlip3, &ch, ul_ch, 8);
...@@ -414,7 +351,7 @@ int nr_pusch_channel_estimation(PHY_VARS_gNB *gNB, ...@@ -414,7 +351,7 @@ int nr_pusch_channel_estimation(PHY_VARS_gNB *gNB,
ul_ch += 8; ul_ch += 8;
c16multaddVectRealComplex(filt8_avlip5, &ch, ul_ch, 8); c16multaddVectRealComplex(filt8_avlip5, &ch, ul_ch, 8);
ul_ch -= 8; ul_ch -= 8;
#endif #endif
} }
// Last PRB // Last PRB
...@@ -435,19 +372,19 @@ int nr_pusch_channel_estimation(PHY_VARS_gNB *gNB, ...@@ -435,19 +372,19 @@ int nr_pusch_channel_estimation(PHY_VARS_gNB *gNB,
re_offset = (re_offset+5) % symbolSize; re_offset = (re_offset+5) % symbolSize;
ch=c16x32div(ch0, 4); ch=c16x32div(ch0, 4);
#if NO_INTERP #if NO_INTERP
for (c16_t *end=ul_ch+12; ul_ch<end; ul_ch++) for (c16_t *end=ul_ch+12; ul_ch<end; ul_ch++)
*ul_ch=ch; *ul_ch=ch;
#else #else
ul_ch[3] = c16maddShift(ch, (c16_t){1365, 1365}, (c16_t){0, 0}, 15); // 1365 = 1/12*16384 (full range is +/- 32768) ul_ch[3] = c16maddShift(ch, (c16_t){1365, 1365}, (c16_t){0, 0}, 15); // 1365 = 1/12*16384 (full range is +/- 32768)
ul_ch += 4; ul_ch += 4;
c16multaddVectRealComplex(filt8_avlip3, &ch, ul_ch, 8); c16multaddVectRealComplex(filt8_avlip3, &ch, ul_ch, 8);
ul_ch += 8; ul_ch += 8;
c16multaddVectRealComplex(filt8_avlip6, &ch, ul_ch, 8); c16multaddVectRealComplex(filt8_avlip6, &ch, ul_ch, 8);
#endif #endif
} }
#ifdef DEBUG_PUSCH #ifdef DEBUG_PUSCH
ul_ch = &ul_ch_estimates[nl * gNB->frame_parms.nb_antennas_rx + aarx][ch_offset]; ul_ch = &ul_ch_estimates[nl * gNB->frame_parms.nb_antennas_rx + aarx][ch_offset];
for (int idxP = 0; idxP < ceil((float)nb_rb_pusch * 12 / 8); idxP++) { for (int idxP = 0; idxP < ceil((float)nb_rb_pusch * 12 / 8); idxP++) {
for (int idxI = 0; idxI < 8; idxI++) { for (int idxI = 0; idxI < 8; idxI++) {
...@@ -455,8 +392,122 @@ int nr_pusch_channel_estimation(PHY_VARS_gNB *gNB, ...@@ -455,8 +392,122 @@ int nr_pusch_channel_estimation(PHY_VARS_gNB *gNB,
} }
printf("%d\n", idxP); printf("%d\n", idxP);
} }
#endif
return 0;
}
int nr_pusch_channel_estimation(PHY_VARS_gNB *gNB,
unsigned char Ns,
int nl,
unsigned short p,
unsigned char symbol,
int ul_id,
unsigned short bwp_start_subcarrier,
nfapi_nr_pusch_pdu_t *pusch_pdu,
int *max_ch,
uint32_t *nvar)
{
c16_t pilot[3280] __attribute__((aligned(32)));
const int chest_freq = gNB->chest_freq;
#ifdef DEBUG_CH
FILE *debug_ch_est;
debug_ch_est = fopen("debug_ch_est.txt","w");
#endif #endif
NR_gNB_PUSCH *pusch_vars = &gNB->pusch_vars[ul_id];
c16_t **ul_ch_estimates = (c16_t **)pusch_vars->ul_ch_estimates;
const int symbolSize = gNB->frame_parms.ofdm_symbol_size;
const int soffset = (Ns & 3) * gNB->frame_parms.symbols_per_slot*symbolSize;
const int nushift = (p >> 1) & 1;
int ch_offset = symbolSize*symbol;
const int symbol_offset = symbolSize*symbol;
const int k0 = bwp_start_subcarrier;
const int nb_rb_pusch = pusch_pdu->rb_size;
LOG_D(PHY, "ch_offset %d, soffset %d, symbol_offset %d, OFDM size %d, Ns = %d, k0 = %d, symbol %d\n",
ch_offset, soffset,
symbol_offset,
symbolSize,
Ns,
k0,
symbol);
//------------------generate DMRS------------------//
if(pusch_pdu->ul_dmrs_scrambling_id != gNB->pusch_gold_init[pusch_pdu->scid]) {
gNB->pusch_gold_init[pusch_pdu->scid] = pusch_pdu->ul_dmrs_scrambling_id;
nr_gold_pusch(gNB, pusch_pdu->scid, pusch_pdu->ul_dmrs_scrambling_id);
}
if (pusch_pdu->transform_precoding == transformPrecoder_disabled) {
// Note: pilot returned by the following function is already the complex conjugate of the transmitted DMRS
nr_pusch_dmrs_rx(gNB,
Ns,
gNB->nr_gold_pusch_dmrs[pusch_pdu->scid][Ns][symbol],
pilot,
(1000 + p),
0,
nb_rb_pusch,
(pusch_pdu->bwp_start + pusch_pdu->rb_start) * NR_NB_SC_PER_RB,
pusch_pdu->dmrs_config_type);
} else { // if transform precoding or SC-FDMA is enabled in Uplink
// NR_SC_FDMA supports type1 DMRS so only 6 DMRS REs per RB possible
const int index = get_index_for_dmrs_lowpapr_seq(nb_rb_pusch * (NR_NB_SC_PER_RB / 2));
const uint8_t u = pusch_pdu->dfts_ofdm.low_papr_group_number;
const uint8_t v = pusch_pdu->dfts_ofdm.low_papr_sequence_number;
c16_t *dmrs_seq = gNB_dmrs_lowpaprtype1_sequence[u][v][index];
LOG_D(PHY,"Transform Precoding params. u: %d, v: %d, index for dmrsseq: %d\n", u, v, index);
AssertFatal(index >= 0, "Num RBs not configured according to 3GPP 38.211 section 6.3.1.4. For PUSCH with transform precoding, num RBs cannot be multiple of any other primenumber other than 2,3,5\n");
AssertFatal(dmrs_seq != NULL, "DMRS low PAPR seq not found, check if DMRS sequences are generated");
nr_pusch_lowpaprtype1_dmrs_rx(gNB, Ns, dmrs_seq, pilot, 1000, 0, nb_rb_pusch, 0, pusch_pdu->dmrs_config_type);
#ifdef DEBUG_PUSCH
printf ("NR_UL_CHANNEL_EST: index %d, u %d,v %d\n", index, u, v);
LOG_M("gNb_DMRS_SEQ.m","gNb_DMRS_SEQ", dmrs_seq,6*nb_rb_pusch,1,1);
#endif
}
//------------------------------------------------//
#ifdef DEBUG_PUSCH
for (int i = 0; i < (6 * nb_rb_pusch); i++) {
LOG_I(PHY, "In %s: %d + j*(%d)\n", __FUNCTION__, pilot[i].r,pilot[i].i);
}
#endif
int nest_count = 0;
uint64_t noise_amp2 = 0;
c16_t ul_ls_est[symbolSize] __attribute__((aligned(32)));
memset(ul_ls_est, 0, sizeof(c16_t) * symbolSize);
delay_t *delay = &gNB->ulsch[ul_id].delay;
memset(delay, 0, sizeof(*delay));
for (int aarx=0; aarx<gNB->frame_parms.nb_antennas_rx; aarx++) {
inner_channel_estimation (
gNB
, aarx
, symbol_offset
, ul_ch_estimates
, nl
, ch_offset
, symbolSize
, pusch_pdu
, chest_freq
, pilot
, k0
, nb_rb_pusch
, p
, soffset
, max_ch
, ul_ls_est
, pusch_vars
, delay
, noise_amp2
, nest_count
, nushift
);
} }
#ifdef DEBUG_CH #ifdef DEBUG_CH
......
Markdown is supported
0%
or
You are about to add 0 people to the discussion. Proceed with caution.
Finish editing this message first!
Please register or to comment