2024-11-29 15:29:45 +00:00
|
|
|
|
#ifndef GPUTOOL_H
|
|
|
|
|
#define GPUTOOL_H
|
|
|
|
|
#ifdef __CUDANVCC___
|
|
|
|
|
#include "BaseConstVariable.h"
|
|
|
|
|
#include <cuda_runtime.h>
|
|
|
|
|
#include <device_launch_parameters.h>
|
|
|
|
|
#include <cublas_v2.h>
|
|
|
|
|
#include <cuComplex.h>
|
|
|
|
|
|
2024-12-01 06:44:58 +00:00
|
|
|
|
#define __CUDADEBUG__
|
|
|
|
|
|
2024-11-29 15:29:45 +00:00
|
|
|
|
// Ĭ<><C4AC><EFBFBD>Դ<EFBFBD><D4B4>ֲ<EFBFBD>
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
enum LAMPGPUDATETYPE {
|
|
|
|
|
LAMP_LONG,
|
|
|
|
|
LAMP_FLOAT,
|
|
|
|
|
LAMP_COMPLEXFLOAT
|
|
|
|
|
};
|
|
|
|
|
|
|
|
|
|
|
2024-11-30 13:07:10 +00:00
|
|
|
|
extern "C" struct CUDASigmaParam {
|
|
|
|
|
float p1;
|
|
|
|
|
float p2;
|
|
|
|
|
float p3;
|
|
|
|
|
float p4;
|
|
|
|
|
float p5;
|
|
|
|
|
float p6;
|
|
|
|
|
};
|
|
|
|
|
|
|
|
|
|
extern "C" struct CUDAVector {
|
|
|
|
|
float x;
|
|
|
|
|
float y;
|
|
|
|
|
float z;
|
|
|
|
|
};
|
2024-11-29 15:29:45 +00:00
|
|
|
|
|
2024-11-30 13:07:10 +00:00
|
|
|
|
extern "C" struct CUDAVectorEllipsoidal {
|
|
|
|
|
float theta;
|
|
|
|
|
float phi;
|
|
|
|
|
float pho;
|
|
|
|
|
};
|
2024-11-29 15:29:45 +00:00
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
// GPU <20>ڴ溯<DAB4><E6BAAF>
|
2024-11-30 13:07:10 +00:00
|
|
|
|
extern "C" void* mallocCUDAHost( long memsize); // <20><><EFBFBD><EFBFBD><EFBFBD>ڴ<EFBFBD><DAB4><EFBFBD><EFBFBD><EFBFBD>
|
2024-11-29 15:29:45 +00:00
|
|
|
|
extern "C" void FreeCUDAHost(void* ptr);
|
2024-11-30 13:07:10 +00:00
|
|
|
|
extern "C" void* mallocCUDADevice( long memsize); // GPU<50>ڴ<EFBFBD><DAB4><EFBFBD><EFBFBD><EFBFBD>
|
2024-11-29 15:29:45 +00:00
|
|
|
|
extern "C" void FreeCUDADevice(void* ptr);
|
|
|
|
|
extern "C" void HostToDevice(void* hostptr, void* deviceptr, long memsize);//GPU <20>ڴ<EFBFBD><DAB4><EFBFBD><EFBFBD><EFBFBD>ת<EFBFBD><D7AA> <20>豸 -> GPU
|
|
|
|
|
extern "C" void DeviceToHost(void* hostptr, void* deviceptr, long memsize);//GPU <20>ڴ<EFBFBD><DAB4><EFBFBD><EFBFBD><EFBFBD>ת<EFBFBD><D7AA> GPU -> <20>豸
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
// <20><><EFBFBD><EFBFBD><EFBFBD><EFBFBD><EFBFBD><EFBFBD><EFBFBD>ij<EFBFBD><C4B3>ú<EFBFBD><C3BA><EFBFBD>
|
|
|
|
|
extern "C" void distanceAB(float* Ax, float* Ay, float* Az, float* Bx, float* By, float* Bz, float* R, long member);
|
|
|
|
|
extern "C" void BdistanceAs(float* Ax, float* Ay, float* Az, float Bx, float By, float Bz, float* R, long member);
|
|
|
|
|
extern "C" void make_VectorA_B(float sX, float sY, float sZ, float* tX, float* tY, float* tZ, float* RstX, float* RstY, float* RstZ, long member);
|
|
|
|
|
extern "C" void Norm_Vector(float* Vx, float* Vy, float* Vz, float* R, long member);
|
|
|
|
|
extern "C" void cosAngle_VA_AB(float* Ax, float* Ay, float* Az, float* Bx, float* By, float* Bz, float* anglecos, long len);
|
|
|
|
|
extern "C" void SatelliteAntDirectNormal(float* RstX, float* RstY, float* RstZ, float antXaxisX, float antXaxisY, float antXaxisZ, float antYaxisX, float antYaxisY, float antYaxisZ, float antZaxisX, float antZaxisY, float antZaxisZ, float antDirectX, float antDirectY, float antDirectZ, float* thetaAnt, float* phiAnt, long len);
|
2024-11-30 13:07:10 +00:00
|
|
|
|
extern "C" void CUDA_RTPC_SiglePRF(
|
2024-12-01 06:44:58 +00:00
|
|
|
|
float antPx, float antPy, float antPZ,
|
|
|
|
|
float antXaxisX, float antXaxisY, float antXaxisZ,
|
|
|
|
|
float antYaxisX, float antYaxisY, float antYaxisZ,
|
2024-11-30 13:07:10 +00:00
|
|
|
|
float antZaxisX, float antZaxisY, float antZaxisZ,
|
2024-12-01 06:44:58 +00:00
|
|
|
|
float antDirectX, float antDirectY, float antDirectZ,
|
|
|
|
|
float* demx, float* demy, float* demz, long* demcls,
|
|
|
|
|
float* demslopex, float* demslopey, float* demslopez, float* demslopeangle,
|
|
|
|
|
float* Tantpattern, float Tstarttheta, float Tstartphi, float Tdtheta, float Tdphi, int Tthetapoints, int Tphipoints,
|
|
|
|
|
float* Rantpattern, float Rstarttheta, float Rstartphi, float Rdtheta, float Rdphi, int Rthetapoints, int Rphipoints,
|
|
|
|
|
float lamda, float fs, float nearrange, float Pt, int Freqnumbers,
|
|
|
|
|
CUDASigmaParam* sigma0Paramslist, int sigmaparamslistlen,
|
|
|
|
|
cuComplex* outecho, int* d_echoAmpFID,
|
|
|
|
|
int linecount, int colcount
|
2024-11-30 13:07:10 +00:00
|
|
|
|
);
|
|
|
|
|
|
2024-12-01 06:44:58 +00:00
|
|
|
|
extern "C" void CUDARTPCPRF(float antPx, long len);
|
|
|
|
|
|
|
|
|
|
|
2024-11-30 13:07:10 +00:00
|
|
|
|
|
2024-12-01 06:44:58 +00:00
|
|
|
|
extern "C" void CUDATestHelloWorld(float a, long len);
|
2024-11-29 15:29:45 +00:00
|
|
|
|
|
|
|
|
|
#endif
|
|
|
|
|
#endif
|
|
|
|
|
|
|
|
|
|
|
2024-11-30 13:07:10 +00:00
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
2024-11-29 15:29:45 +00:00
|
|
|
|
/**
|
|
|
|
|
*
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
double* databuffer = new double[nXSize * nYSize * 2];
|
|
|
|
|
poBand->RasterIO(GF_Read, start_col, start_row, cols_count, rows_count, databuffer, cols_count,
|
|
|
|
|
rows_count, GDT_CFloat64, 0, 0);
|
|
|
|
|
GDALClose((GDALDatasetH)poDataset);
|
|
|
|
|
Eigen::MatrixXcd rasterData(nYSize, nXSize); // ʹ<><CAB9>Eigen<65><6E>MatrixXcd
|
|
|
|
|
for(size_t i = 0; i < nYSize; i++) {
|
|
|
|
|
for(size_t j = 0; j < nXSize; j++) {
|
|
|
|
|
rasterData(i, j) = std::complex<double>(databuffer[i * nXSize * 2 + j * 2],
|
|
|
|
|
databuffer[i * nXSize * 2 + j * 2 + 1]);
|
|
|
|
|
}
|
|
|
|
|
}
|
|
|
|
|
|
|
|
|
|
delete[] databuffer;
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
gdalImage demxyz(demxyzPath);// <20><><EFBFBD><EFBFBD><EFBFBD><EFBFBD><EFBFBD><EFBFBD><EFBFBD><EFBFBD>
|
|
|
|
|
gdalImage demlandcls(this->LandCoverPath);// <20>ر<EFBFBD><D8B1><EFBFBD><EFBFBD><EFBFBD><EFBFBD><EFBFBD><EFBFBD><EFBFBD>
|
|
|
|
|
gdalImage demsloperxyz(this->demsloperPath);// <20><><EFBFBD><EFBFBD><EFBFBD><EFBFBD><EFBFBD><EFBFBD>
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
omp_lock_t lock; // <20><><EFBFBD><EFBFBD><EFBFBD><EFBFBD>
|
|
|
|
|
omp_init_lock(&lock); // <20><>ʼ<EFBFBD><CABC><EFBFBD><EFBFBD>
|
|
|
|
|
long start_ids = 1250;
|
|
|
|
|
for (start_ids = 1; start_ids < demxyz.height; start_ids = start_ids + line_invert) { // 8+ 17 + 0.3 MB
|
|
|
|
|
QDateTime current = QDateTime::currentDateTime();
|
|
|
|
|
long pluseStep = Memory1MB * 100 / 3 / PlusePoint;
|
|
|
|
|
if (pluseStep * num_thread * 3 > this->PluseCount) {
|
|
|
|
|
pluseStep = this->PluseCount / num_thread / 3;
|
|
|
|
|
}
|
|
|
|
|
pluseStep = pluseStep > 50 ? pluseStep : 50;
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
qDebug() << current.toString("yyyy-MM-dd HH:mm:ss.zzz") << " \tstart \t " << start_ids << " - " << start_ids + line_invert << "\t" << demxyz.height << "\t pluseCount:\t" << pluseStep;
|
|
|
|
|
// <20>ļ<EFBFBD><C4BC><EFBFBD>ȡ
|
|
|
|
|
Eigen::MatrixXd dem_x = demxyz.getData(start_ids - 1, 0, line_invert + 1, demxyz.width, 1); //
|
|
|
|
|
Eigen::MatrixXd dem_y = demxyz.getData(start_ids - 1, 0, line_invert + 1, demxyz.width, 2); //
|
|
|
|
|
Eigen::MatrixXd dem_z = demxyz.getData(start_ids - 1, 0, line_invert + 1, demxyz.width, 3); //
|
|
|
|
|
|
|
|
|
|
// <20>ر<EFBFBD><D8B1><EFBFBD><EFBFBD><EFBFBD>
|
|
|
|
|
std::shared_ptr<long> dem_landcls = readDataArr<long>(demlandcls, start_ids - 1, 0, line_invert + 1, demxyz.width, 1, GDALREADARRCOPYMETHOD::VARIABLEMETHOD); // <20>ر<EFBFBD><D8B1><EFBFBD><EFBFBD><EFBFBD><EFBFBD><EFBFBD><EFBFBD><EFBFBD>
|
|
|
|
|
long* dem_landcls_ptr = dem_landcls.get();
|
|
|
|
|
double localAngle = 30.0;
|
|
|
|
|
|
|
|
|
|
bool sigmaNoZeroFlag = true;
|
|
|
|
|
for (long ii = 0; ii < dem_x.rows(); ii++) {
|
|
|
|
|
for (long jj = 0; jj < dem_y.cols(); jj++) {
|
|
|
|
|
if (0 != this->SigmaDatabasePtr->getAmp(dem_landcls_ptr[dem_x.cols() * ii + jj], localAngle, polartype)) {
|
|
|
|
|
sigmaNoZeroFlag = false;
|
|
|
|
|
break;
|
|
|
|
|
}
|
|
|
|
|
}
|
|
|
|
|
if (!sigmaNoZeroFlag) {
|
|
|
|
|
break;
|
|
|
|
|
}
|
|
|
|
|
}
|
|
|
|
|
if (sigmaNoZeroFlag) {
|
|
|
|
|
continue;
|
|
|
|
|
}
|
|
|
|
|
|
|
|
|
|
//#ifdef DEBUGSHOWDIALOG
|
|
|
|
|
// dialog->load_double_MatrixX_data(dem_z, "dem_z");
|
|
|
|
|
//#endif
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
Eigen::MatrixXd demsloper_x = demsloperxyz.getData(start_ids - 1, 0, line_invert + 1, demxyz.width, 1); //
|
|
|
|
|
Eigen::MatrixXd demsloper_y = demsloperxyz.getData(start_ids - 1, 0, line_invert + 1, demxyz.width, 2); //
|
|
|
|
|
Eigen::MatrixXd demsloper_z = demsloperxyz.getData(start_ids - 1, 0, line_invert + 1, demxyz.width, 3); //
|
|
|
|
|
Eigen::MatrixXd sloperAngle = demsloperxyz.getData(start_ids - 1, 0, line_invert + 1, demxyz.width, 4); //
|
|
|
|
|
sloperAngle = sloperAngle.array() * T180_PI;
|
|
|
|
|
|
|
|
|
|
long dem_rows = dem_x.rows();
|
|
|
|
|
long dem_cols = dem_x.cols();
|
|
|
|
|
|
|
|
|
|
long freqidx = 0;//
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
#ifdef DEBUGSHOWDIALOG
|
|
|
|
|
ImageShowDialogClass* dialog = new ImageShowDialogClass(nullptr);
|
|
|
|
|
dialog->show();
|
|
|
|
|
|
|
|
|
|
Eigen::MatrixXd landaArr = Eigen::MatrixXd::Zero(dem_rows, dem_cols);
|
|
|
|
|
for (long i = 0; i < dem_rows; i++) {
|
|
|
|
|
for (long j = 0; j < dem_cols; j++) {
|
|
|
|
|
landaArr(i, j) = dem_landcls.get()[i * dem_cols + j];
|
|
|
|
|
}
|
|
|
|
|
}
|
|
|
|
|
dialog->load_double_MatrixX_data(landaArr, "landCover");
|
|
|
|
|
#endif
|
|
|
|
|
//qDebug() << " pluse bolck size :\t " << pluseStep << " all size:\t" << this->PluseCount;
|
|
|
|
|
long processNumber = 0;
|
|
|
|
|
|
|
|
|
|
#pragma omp parallel for
|
|
|
|
|
for (long startprfidx = 0; startprfidx < this->PluseCount; startprfidx = startprfidx + pluseStep) { // 17 + 0.3 MB
|
|
|
|
|
long prfcount_step = startprfidx + pluseStep < this->PluseCount ? pluseStep : this->PluseCount - startprfidx;
|
|
|
|
|
Eigen::MatrixXcd echoPluse = Eigen::MatrixXcd::Zero(prfcount_step, PlusePoint); // <20><>ǰ<EFBFBD><C7B0><EFBFBD><EFBFBD><EFBFBD>Ļز<C4BB><D8B2><EFBFBD><EFBFBD><EFBFBD><EFBFBD><EFBFBD><EFBFBD><EFBFBD>
|
|
|
|
|
// <20>ڴ<EFBFBD>Ԥ<EFBFBD><D4A4><EFBFBD><EFBFBD>
|
|
|
|
|
Eigen::MatrixXd Rst_x = Eigen::MatrixXd::Zero(dem_x.rows(), dem_x.cols());
|
|
|
|
|
Eigen::MatrixXd Rst_y = Eigen::MatrixXd::Zero(dem_x.rows(), dem_x.cols());
|
|
|
|
|
Eigen::MatrixXd Rst_z = Eigen::MatrixXd::Zero(dem_x.rows(), dem_x.cols());
|
|
|
|
|
Eigen::MatrixXd R = Eigen::MatrixXd::Zero(dem_x.rows(), dem_x.cols());
|
|
|
|
|
Eigen::MatrixXd localangle = Eigen::MatrixXd::Zero(dem_x.rows(), dem_x.cols());
|
|
|
|
|
Eigen::MatrixXd Vst_x = Eigen::MatrixXd::Zero(dem_x.rows(), dem_x.cols());
|
|
|
|
|
Eigen::MatrixXd Vst_y = Eigen::MatrixXd::Zero(dem_x.rows(), dem_x.cols());
|
|
|
|
|
Eigen::MatrixXd Vst_z = Eigen::MatrixXd::Zero(dem_x.rows(), dem_x.cols());
|
|
|
|
|
Eigen::MatrixXd fde = Eigen::MatrixXd::Zero(dem_x.rows(), dem_x.cols());
|
|
|
|
|
Eigen::MatrixXd fr = Eigen::MatrixXd::Zero(dem_x.rows(), dem_x.cols());
|
|
|
|
|
Eigen::MatrixXd Rx = Eigen::MatrixXd::Zero(dem_x.rows(), dem_x.cols());
|
|
|
|
|
Eigen::MatrixXd sigam = Eigen::MatrixXd::Zero(dem_x.rows(), dem_x.cols());
|
|
|
|
|
Eigen::MatrixXd echoAmp = Eigen::MatrixXd::Zero(dem_x.rows(), dem_x.cols()).array() + Pt;
|
|
|
|
|
Eigen::MatrixXd Rphi = Eigen::MatrixXd::Zero(dem_x.rows(), dem_x.cols());
|
|
|
|
|
Eigen::MatrixXd TimeRange = Eigen::MatrixXd::Zero(dem_x.rows(), dem_x.cols());
|
|
|
|
|
Eigen::MatrixXd TransAnt = Eigen::MatrixXd::Zero(dem_x.rows(), dem_x.cols());
|
|
|
|
|
Eigen::MatrixXd ReciveAnt = Eigen::MatrixXd::Zero(dem_x.rows(), dem_x.cols());
|
|
|
|
|
|
|
|
|
|
Eigen::MatrixXd AntTheta = Eigen::MatrixXd::Zero(dem_x.rows(), dem_x.cols());
|
|
|
|
|
Eigen::MatrixXd AntPhi = Eigen::MatrixXd::Zero(dem_x.rows(), dem_x.cols());
|
|
|
|
|
|
|
|
|
|
double minR = 0, maxR = 0;
|
|
|
|
|
double minLocalAngle = 0, maxLocalAngle = 0;
|
|
|
|
|
|
|
|
|
|
Vector3D Rt = { 0,0,0 };
|
|
|
|
|
SatelliteOribtNode oRs = SatelliteOribtNode{ 0 };;
|
|
|
|
|
|
|
|
|
|
Vector3D p0 = {}, slopeVector = {}, sateAntDirect = {};
|
|
|
|
|
Vector3D Rs = {}, Vs = {}, Ast = {};
|
|
|
|
|
SatelliteAntDirect antdirectNode = {};
|
|
|
|
|
std::complex<double> echofreq;
|
|
|
|
|
std::complex<double> Imag1(0, 1);
|
|
|
|
|
double TAntPattern = 1; // <20><><EFBFBD><EFBFBD><EFBFBD><EFBFBD><EFBFBD>߷<EFBFBD><DFB7><EFBFBD>ͼ
|
|
|
|
|
double RAntPanttern = 1;// <20><><EFBFBD><EFBFBD><EFBFBD><EFBFBD><EFBFBD>߷<EFBFBD><DFB7><EFBFBD>ͼ
|
|
|
|
|
double maxechoAmp = 1;
|
|
|
|
|
double tempAmp = 1;
|
|
|
|
|
for (long prfidx = 0; prfidx < prfcount_step; prfidx++)
|
|
|
|
|
{
|
|
|
|
|
oRs = sateOirbtNodes[prfidx + startprfidx];
|
|
|
|
|
|
|
|
|
|
// <20><><EFBFBD><EFBFBD><EFBFBD><EFBFBD><EFBFBD>߷<EFBFBD><DFB7><EFBFBD>ͼ
|
|
|
|
|
for (long jj = 1; jj < dem_cols - 1; jj++) {
|
|
|
|
|
for (long ii = 1; ii < dem_rows - 1; ii++) {
|
|
|
|
|
p0.x = dem_x(ii, jj);
|
|
|
|
|
p0.y = dem_y(ii, jj);
|
|
|
|
|
p0.z = dem_z(ii, jj);
|
|
|
|
|
this->TaskSetting->getSatelliteAntDirectNormal(oRs, p0, antdirectNode);
|
|
|
|
|
//antdirectNode.ThetaAnt = antdirectNode.ThetaAnt * r2d;
|
|
|
|
|
//antdirectNode.PhiAnt = antdirectNode.PhiAnt * r2d;
|
|
|
|
|
AntTheta(ii, jj) = antdirectNode.ThetaAnt * r2d;
|
|
|
|
|
AntPhi(ii, jj) = antdirectNode.PhiAnt * r2d;
|
|
|
|
|
}
|
|
|
|
|
}
|
|
|
|
|
|
|
|
|
|
// <20><><EFBFBD>㷢<EFBFBD><E3B7A2><EFBFBD><EFBFBD><EFBFBD>߷<EFBFBD><DFB7><EFBFBD>ͼ
|
|
|
|
|
for (long jj = 1; jj < dem_cols - 1; jj++) {
|
|
|
|
|
for (long ii = 1; ii < dem_rows - 1; ii++) {
|
|
|
|
|
TransformPattern->getGainLinear(AntTheta(ii, jj), AntPhi(ii, jj), TransAnt(ii, jj));
|
|
|
|
|
//TransAnt(ii, jj) = TAntPattern;
|
|
|
|
|
}
|
|
|
|
|
}
|
|
|
|
|
|
|
|
|
|
// <20><><EFBFBD><EFBFBD><EFBFBD><EFBFBD><EFBFBD><EFBFBD><EFBFBD><EFBFBD><EFBFBD>߷<EFBFBD><DFB7><EFBFBD>ͼ
|
|
|
|
|
for (long jj = 1; jj < dem_cols - 1; jj++) {
|
|
|
|
|
for (long ii = 1; ii < dem_rows - 1; ii++) {
|
|
|
|
|
TransformPattern->getGainLinear(AntTheta(ii, jj), AntPhi(ii, jj), ReciveAnt(ii, jj));
|
|
|
|
|
//ReciveAnt(ii, jj) = RAntPanttern;
|
|
|
|
|
}
|
|
|
|
|
}
|
|
|
|
|
|
|
|
|
|
// <20><><EFBFBD>㾭<EFBFBD><E3BEAD><EFBFBD><EFBFBD><EFBFBD><EFBFBD><EFBFBD><EFBFBD><EFBFBD><EFBFBD><EFBFBD><EFBFBD>
|
|
|
|
|
echoAmp = Pt * TransAnt.array() * ReciveAnt.array();
|
|
|
|
|
|
|
|
|
|
maxechoAmp = echoAmp.maxCoeff();
|
|
|
|
|
if (std::abs(maxechoAmp) < PRECISIONTOLERANCE) { // <20><><EFBFBD><EFBFBD><EFBFBD><EFBFBD><EFBFBD><EFBFBD><EFBFBD>£<EFBFBD><C2A3><EFBFBD><EFBFBD>ںϳɿ<C9BF><D7BE><EFBFBD>Χ<EFBFBD><CEA7>
|
|
|
|
|
continue;
|
|
|
|
|
}
|
|
|
|
|
|
|
|
|
|
Rs.x = sateOirbtNodes[prfidx + startprfidx].Px; // <20><><EFBFBD><EFBFBD>λ<EFBFBD><CEBB>
|
|
|
|
|
Rs.y = sateOirbtNodes[prfidx + startprfidx].Py;
|
|
|
|
|
Rs.z = sateOirbtNodes[prfidx + startprfidx].Pz;
|
|
|
|
|
|
|
|
|
|
Vs.x = sateOirbtNodes[prfidx + startprfidx].Vx; // <20><><EFBFBD><EFBFBD><EFBFBD>ٶ<EFBFBD>
|
|
|
|
|
Vs.y = sateOirbtNodes[prfidx + startprfidx].Vy;
|
|
|
|
|
Vs.z = sateOirbtNodes[prfidx + startprfidx].Vz;
|
|
|
|
|
|
|
|
|
|
Ast.x = sateOirbtNodes[prfidx + startprfidx].AVx;// <20><><EFBFBD>Ǽ<EFBFBD><C7BC>ٶ<EFBFBD>
|
|
|
|
|
Ast.y = sateOirbtNodes[prfidx + startprfidx].AVy;
|
|
|
|
|
Ast.z = sateOirbtNodes[prfidx + startprfidx].AVz;
|
|
|
|
|
|
|
|
|
|
Rst_x = Rs.x - dem_x.array(); // Rst = Rs - Rt;
|
|
|
|
|
Rst_y = Rs.y - dem_y.array();
|
|
|
|
|
Rst_z = Rs.z - dem_z.array();
|
|
|
|
|
R = (Rst_x.array().pow(2) + Rst_y.array().pow(2) + Rst_z.array().pow(2)).array().sqrt(); // R
|
|
|
|
|
|
|
|
|
|
minR = R.minCoeff();
|
|
|
|
|
maxR = R.maxCoeff();
|
|
|
|
|
//qDebug() << "minR:\t" << minR << " maxR:\t" << maxR;
|
|
|
|
|
if (maxR<NearRange || minR>FarRange) {
|
|
|
|
|
continue;
|
|
|
|
|
}
|
|
|
|
|
else {}
|
|
|
|
|
|
|
|
|
|
// getCosAngle
|
|
|
|
|
// double c = dot(a, b) / (getlength(a) * getlength(b));
|
|
|
|
|
// return acos(c > 1 ? 1 : c < -1 ? -1 : c) * r2d;
|
|
|
|
|
// localangle = getCosAngle(Rst, slopeVector) * T180_PI; // ע<><D7A2><EFBFBD><EFBFBD><EFBFBD><EFBFBD>ֻ<EFBFBD><D6BB>ʵʱ<CAB5><CAB1><EFBFBD>㣬<EFBFBD><E3A3AC>Ϊ<EFBFBD><CEAA>ʵʱ<CAB5><CAB1><EFBFBD><EFBFBD><EFBFBD><EFBFBD><EFBFBD><EFBFBD>̫<EFBFBD><CCAB>
|
|
|
|
|
localangle = (Rst_x.array() * demsloper_x.array() + Rst_y.array() * demsloper_y.array() + Rst_z.array() * demsloper_z.array()).array(); // dot(a, b)
|
|
|
|
|
localangle = localangle.array() / R.array();
|
|
|
|
|
localangle = localangle.array() / (demsloper_x.array().pow(2) + demsloper_y.array().pow(2) + demsloper_z.array().pow(2)).array().sqrt().array();
|
|
|
|
|
localangle = localangle.array().acos(); // <20><><EFBFBD><EFBFBD>ֵ
|
|
|
|
|
|
|
|
|
|
minLocalAngle = localangle.minCoeff();
|
|
|
|
|
maxLocalAngle = localangle.maxCoeff();
|
|
|
|
|
if (maxLocalAngle<0 || minLocalAngle>PI / 2) {
|
|
|
|
|
continue;
|
|
|
|
|
}
|
|
|
|
|
else {}
|
|
|
|
|
|
|
|
|
|
//Vst_x = Vs.x + 1 * earthRoute * dem_y.array(); // Vst = Vs - Vt;
|
|
|
|
|
//Vst_y = Vs.y - 1 * earthRoute * dem_x.array();
|
|
|
|
|
//Vst_z = Vs.z - Eigen::MatrixXd::Zero(dem_x.rows(), dem_y.cols()).array();
|
|
|
|
|
|
|
|
|
|
//// <20><><EFBFBD><EFBFBD><EFBFBD><EFBFBD><EFBFBD><EFBFBD><EFBFBD><EFBFBD><EFBFBD><EFBFBD><EFBFBD><EFBFBD>Ƶ<EFBFBD><C6B5> Rst, Vst : ( - 2 / lamda) * dot(Rs - Rt, Vs - Vt) / R; // <20><><EFBFBD>غϳɿ<C9BF><D7BE>״<EFBFBD>ԭʼ<D4AD>ز<EFBFBD><D8B2><EFBFBD><EFBFBD><EFBFBD>ģ<EFBFBD><C4A3><EFBFBD>о<EFBFBD> 3.18
|
|
|
|
|
//fde = (-2 / lamda) * (Rst_x.array() * Vst_x.array() + Rst_y.array() * Vst_y.array() + Rst_z.array() * Vst_z.array()).array() / (R.array());
|
|
|
|
|
//// <20><><EFBFBD><EFBFBD><EFBFBD><EFBFBD><EFBFBD><EFBFBD><EFBFBD><EFBFBD>Ƶ<EFBFBD><C6B5>б<EFBFBD><D0B1> // <20><><EFBFBD>غϳɿ<C9BF><D7BE>״<EFBFBD>ԭʼ<D4AD>ز<EFBFBD><D8B2><EFBFBD><EFBFBD><EFBFBD>ģ<EFBFBD><C4A3><EFBFBD>о<EFBFBD> 3.19
|
|
|
|
|
//// -(2/lamda)*( dot(Vs - Vt, Vs - Vt)/R + dot(Ast, Rs - Rt)/R - std::pow(dot(Vs - Vt, Rs - Rt),2 )/std::pow(R,3));
|
|
|
|
|
//fr = (-2 / lamda) *
|
|
|
|
|
// (Vst_x.array() * Vst_x.array() + Vst_y.array() * Vst_y.array() + Vst_z.array() * Vst_z.array()).array() / (R.array()) +
|
|
|
|
|
// (-2 / lamda) *
|
|
|
|
|
// (Ast.x * Rst_x.array() + Ast.y * Rst_y.array() + Ast.z * Rst_z.array()).array() / (R.array()) -
|
|
|
|
|
// (-2 / lamda) *
|
|
|
|
|
// (Vst_x.array() * Rst_x.array() + Vst_y.array() * Rst_y.array() + Vst_z.array() * Rst_z.array()).array().pow(2) / (R.array().pow(3));
|
|
|
|
|
// <20><><EFBFBD><EFBFBD><EFBFBD>ز<EFBFBD>
|
|
|
|
|
Rx = R;// -(lamda / 2) * (fde * TRx + 0.5 * fr * TRx * TRx); // б<><D0B1><EFBFBD><EFBFBD><EFBFBD><EFBFBD>ֵ
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
// <20><><EFBFBD><EFBFBD><EFBFBD><EFBFBD><EFBFBD><EFBFBD> this->SigmaDatabasePtr->getAmp(covercls, localangle, polartype); // <20><><EFBFBD><EFBFBD>ɢ<EFBFBD><C9A2>ϵ<EFBFBD><CFB5> HH
|
|
|
|
|
|
|
|
|
|
for (long ii = 0; ii < dem_x.rows(); ii++) {
|
|
|
|
|
for (long jj = 0; jj < dem_y.cols(); jj++) {
|
|
|
|
|
sigam(ii, jj) = this->SigmaDatabasePtr->getAmp(dem_landcls_ptr[dem_x.cols() * ii + jj], localangle(ii, jj) * r2d, polartype);
|
|
|
|
|
}
|
|
|
|
|
}
|
|
|
|
|
|
|
|
|
|
if (sigam.maxCoeff() > 0) {}
|
|
|
|
|
else {
|
|
|
|
|
continue;
|
|
|
|
|
}
|
|
|
|
|
// projArea = 1 / std::cos(sloperAngle) * std::sin(localangle); // ͶӰ<CDB6><D3B0><EFBFBD><EFBFBD>ϵ<EFBFBD><CFB5><EFBFBD><EFBFBD><EFBFBD><EFBFBD>λͶӰ<CDB6><D3B0><EFBFBD><EFBFBD> 1m x 1m --ע<><D7A2><EFBFBD><EFBFBD><EFBFBD><EFBFBD><EFBFBD>Ǽ<EFBFBD><C7BC>裬<EFBFBD><E8A3AC><EFBFBD><EFBFBD><EFBFBD>ٲ<EFBFBD><D9B2><EFBFBD>
|
|
|
|
|
// echoAmp = projArea*TAntPattern * RAntPanttern * sigam / (4 * PI * R * R);
|
|
|
|
|
|
|
|
|
|
echoAmp = echoAmp.array() * sigam.array() * (1 / sloperAngle.array().cos() * localangle.array().sin()); // <20><><EFBFBD><EFBFBD>ǿ<EFBFBD><C7BF>
|
|
|
|
|
echoAmp = echoAmp.array() / (4 * PI * R.array().pow(2)); // <20><><EFBFBD><EFBFBD>˥<EFBFBD><CBA5>
|
|
|
|
|
|
|
|
|
|
Rphi = -4 * PI / lamda * Rx.array();// <20><><EFBFBD><EFBFBD><EFBFBD>㶯<EFBFBD><E3B6AF>λ
|
|
|
|
|
// <20><><EFBFBD><EFBFBD>
|
|
|
|
|
TimeRange = ((2 * R.array() / LIGHTSPEED - TimgNearRange).array() * Fs).array();
|
|
|
|
|
double localAnglepoint = -1;
|
|
|
|
|
long prf_freq_id = 0;
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
for (long jj = 1; jj < dem_cols - 1; jj++) {
|
|
|
|
|
for (long ii = 1; ii < dem_rows - 1; ii++) {
|
|
|
|
|
prf_freq_id = std::floor(TimeRange(ii, jj));
|
|
|
|
|
if (prf_freq_id < 0 || prf_freq_id >= PlusePoint || localangle(ii, jj) < 0 || localangle(ii, jj) > PI / 2 || echoAmp(ii, jj) == 0) {
|
|
|
|
|
continue;
|
|
|
|
|
}
|
|
|
|
|
echofreq = echoAmp(ii, jj) * std::exp(Rphi(ii, jj) * Imag1);
|
|
|
|
|
echoPluse(prfidx, prf_freq_id) = echoPluse(prfidx, prf_freq_id) + echofreq;
|
|
|
|
|
}
|
|
|
|
|
}
|
|
|
|
|
|
|
|
|
|
#ifdef DEBUGSHOWDIALOG
|
|
|
|
|
ImageShowDialogClass* localangledialog = new ImageShowDialogClass(dialog);
|
|
|
|
|
localangledialog->show();
|
|
|
|
|
localangledialog->load_double_MatrixX_data(localangle.array() * r2d, "localangle");
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
ImageShowDialogClass* sigamdialog = new ImageShowDialogClass(dialog);
|
|
|
|
|
sigamdialog->show();
|
|
|
|
|
sigamdialog->load_double_MatrixX_data(TimeRange, "TimeRange");
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
ImageShowDialogClass* ampdialog = new ImageShowDialogClass(dialog);
|
|
|
|
|
ampdialog->show();
|
|
|
|
|
ampdialog->load_double_MatrixX_data(echoAmp, "echoAmp");
|
|
|
|
|
|
|
|
|
|
Eigen::MatrixXd echoPluseamp = echoPluse.array().abs().cast<double>().array();
|
|
|
|
|
ImageShowDialogClass* echoampdialog = new ImageShowDialogClass(dialog);
|
|
|
|
|
echoampdialog->show();
|
|
|
|
|
echoampdialog->load_double_MatrixX_data(echoPluseamp, "echoPluseamp");
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
dialog->exec();
|
|
|
|
|
#endif
|
|
|
|
|
//qDebug() << QDateTime::currentDateTime().toString("yyyy-MM-dd HH:mm:ss.zzz") << " end " << prfidx;
|
|
|
|
|
}
|
|
|
|
|
//qDebug() << QDateTime::currentDateTime().toString("yyyy-MM-dd HH:mm:ss.zzz")<<" step "<< prfcount_step;
|
|
|
|
|
|
|
|
|
|
omp_set_lock(&lock); // <20>ز<EFBFBD><D8B2><EFBFBD><EFBFBD>帳ֵ<E5B8B3><D6B5><EFBFBD><EFBFBD>
|
|
|
|
|
for (long prfidx = 0; prfidx < prfcount_step; prfidx++) {
|
|
|
|
|
for (long freqidx = 0; freqidx < PlusePoint; freqidx++)
|
|
|
|
|
{
|
|
|
|
|
//qDebug() << prfidx << " " << freqidx << " " << echoPluse(prfidx, freqidx).real() << " + " << echoPluse(prfidx, freqidx).imag() << " j";
|
|
|
|
|
echo.get()[(prfidx + startprfidx) * PlusePoint + freqidx] = echo.get()[(prfidx + startprfidx) * PlusePoint + freqidx] + echoPluse(prfidx, freqidx);
|
|
|
|
|
}
|
|
|
|
|
}
|
|
|
|
|
//this->EchoSimulationData->saveEchoArr(echo, 0, PluseCount);
|
|
|
|
|
omp_unset_lock(&lock); // <20><><EFBFBD><EFBFBD>
|
|
|
|
|
//qDebug() << QDateTime::currentDateTime().toString("yyyy-MM-dd HH:mm:ss.zzz") << " step 2" << prfcount_step;
|
|
|
|
|
}
|
|
|
|
|
|
|
|
|
|
omp_set_lock(&lock); // <20><><EFBFBD><EFBFBD><EFBFBD>ļ<EFBFBD>
|
|
|
|
|
processNumber = processNumber + pluseStep;
|
|
|
|
|
|
|
|
|
|
this->EchoSimulationData->saveEchoArr(echo, 0, PluseCount);
|
|
|
|
|
omp_unset_lock(&lock); // <20><><EFBFBD><EFBFBD>
|
|
|
|
|
|
|
|
|
|
qDebug() << QDateTime::currentDateTime().toString("yyyy-MM-dd HH:mm:ss.zzz") << " \t " << start_ids << "\t--\t " << start_ids + line_invert << "\t/\t" << demxyz.height;
|
|
|
|
|
|
|
|
|
|
}
|
|
|
|
|
omp_destroy_lock(&lock); // <20><><EFBFBD><EFBFBD><EFBFBD><EFBFBD>
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
|
*/
|