15 #include "nmrspectrumbase.h"
19 #include <graphwidget.h>
20 #include <xwavengraph.h>
22 #include <QPushButton>
28 Transaction &tr_meas,
const shared_ptr<XMeasure> &meas)
31 "PulseAnalyzer", false, ref(tr_meas), meas->drivers(), true)),
32 m_bandWidth(create<
XDoubleNode>(
"BandWidth", false)),
33 m_bwList(create<
XComboNode>(
"BandWidthList", false, true)),
34 m_autoPhase(create<
XBoolNode>(
"AutoPhase", false)),
35 m_phase(create<
XDoubleNode>(
"Phase", false,
"%.2f")),
37 m_solverList(create<
XComboNode>(
"SpectrumSolver", false, true)),
38 m_windowFunc(create<
XComboNode>(
"WindowFunc", false, true)),
39 m_windowWidth(create<
XDoubleNode>(
"WindowWidth", false)),
40 m_solver(create<
SpectrumSolverWrapper>(
"SpectrumSolver", true, m_solverList, m_windowFunc, m_windowWidth)),
43 m_spectrum(create<
XWaveNGraph>(
"Spectrum", true, m_form->m_graph, m_form->m_edDump, m_form->m_tbDump, m_form->m_btnDump)) {
44 m_form->m_btnClear->setIcon(QApplication::style()->standardIcon(QStyle::SP_DialogResetButton));
49 const char *labels[] = {
"X",
"Re [V]",
"Im [V]",
"Weights",
"Abs [V]",
"Dark [V]"};
50 tr[ *m_spectrum].setColCount(6, labels);
51 tr[ *m_spectrum].insertPlot(labels[4], 0, 4, -1, 3);
52 tr[ *m_spectrum].insertPlot(labels[1], 0, 1, -1, 3);
53 tr[ *m_spectrum].insertPlot(labels[2], 0, 2, -1, 3);
54 tr[ *m_spectrum].insertPlot(labels[5], 0, 5, -1, 3);
55 tr[ *tr[ *m_spectrum].axisy()->label()] = i18n(
"Intens. [V]");
56 tr[ *tr[ *m_spectrum].plot(1)->label()] = i18n(
"real part");
57 tr[ *tr[ *m_spectrum].plot(1)->drawPoints()] =
false;
58 tr[ *tr[ *m_spectrum].plot(1)->lineColor()] = clRed;
59 tr[ *tr[ *m_spectrum].plot(2)->label()] = i18n(
"imag. part");
60 tr[ *tr[ *m_spectrum].plot(2)->drawPoints()] =
false;
61 tr[ *tr[ *m_spectrum].plot(2)->lineColor()] = clGreen;
62 tr[ *tr[ *m_spectrum].plot(0)->label()] = i18n(
"abs.");
63 tr[ *tr[ *m_spectrum].plot(0)->drawPoints()] =
false;
64 tr[ *tr[ *m_spectrum].plot(0)->drawLines()] =
true;
65 tr[ *tr[ *m_spectrum].plot(0)->drawBars()] =
true;
66 tr[ *tr[ *m_spectrum].plot(0)->barColor()] = QColor(0x60, 0x60, 0xc0).rgb();
67 tr[ *tr[ *m_spectrum].plot(0)->lineColor()] = QColor(0x60, 0x60, 0xc0).rgb();
68 tr[ *tr[ *m_spectrum].plot(0)->intensity()] = 0.5;
69 tr[ *tr[ *m_spectrum].plot(3)->label()] = i18n(
"dark");
70 tr[ *tr[ *m_spectrum].plot(3)->drawBars()] =
false;
71 tr[ *tr[ *m_spectrum].plot(3)->drawLines()] =
true;
72 tr[ *tr[ *m_spectrum].plot(3)->lineColor()] = QColor(0xa0, 0xa0, 0x00).rgb();
73 tr[ *tr[ *m_spectrum].plot(3)->drawPoints()] =
false;
74 tr[ *tr[ *m_spectrum].plot(3)->intensity()] = 0.5;
76 shared_ptr<XXYPlot> plot = m_spectrum->graph()->plots()->template create<XXYPlot>(
77 tr,
"Peaks",
true, ref(tr), m_spectrum->graph());
79 tr[ *plot->label()] = i18n(
"Peaks");
80 tr[ *plot->axisX()] = tr[ *m_spectrum].axisx();
81 tr[ *plot->axisY()] = tr[ *m_spectrum].axisy();
82 tr[ *plot->drawPoints()] =
false;
83 tr[ *plot->drawLines()] =
false;
84 tr[ *plot->drawBars()] =
true;
85 tr[ *plot->intensity()] = 2.0;
86 tr[ *plot->displayMajorGrid()] =
false;
87 tr[ *plot->pointColor()] = QColor(0xa0, 0x00, 0xa0).rgb();
88 tr[ *plot->barColor()] = QColor(0xa0, 0x00, 0xa0).rgb();
89 tr[ *plot->clearPoints()].setUIEnabled(
false);
90 tr[ *plot->maxCount()].setUIEnabled(
false);
92 tr[ *m_spectrum].clearPoints();
94 tr[ *bandWidth()] = 50;
96 tr[ *
bwList()].add(
"100%");
97 tr[ *
bwList()].add(
"200%");
105 m_form->m_dblPhase->setRange(-360.0, 360.0);
106 m_form->m_dblPhase->setSingleStep(10.0);
107 m_form->m_dblWindowWidth->setRange(0.1, 200.0);
108 m_form->m_dblWindowWidth->setSingleStep(1.0);
111 xqcon_create<XQLineEditConnector>(m_bandWidth, m_form->m_edBW),
112 xqcon_create<XQComboBoxConnector>(m_bwList, m_form->m_cmbBWList,
Snapshot( *m_bwList)),
113 xqcon_create<XQDoubleSpinBoxConnector>(m_phase, m_form->m_dblPhase, m_form->m_slPhase),
114 xqcon_create<XQToggleButtonConnector>(m_autoPhase, m_form->m_ckbAutoPhase),
115 xqcon_create<XQComboBoxConnector>(m_pulse, m_form->m_cmbPulse, ref(tr_meas)),
116 xqcon_create<XQButtonConnector>(m_clear, m_form->m_btnClear),
117 xqcon_create<XQComboBoxConnector>(m_solverList, m_form->m_cmbSolver,
Snapshot( *m_solverList)),
118 xqcon_create<XQDoubleSpinBoxConnector>(m_windowWidth, m_form->m_dblWindowWidth, m_form->m_slWindowWidth),
119 xqcon_create<XQComboBoxConnector>(m_windowFunc, m_form->m_cmbWindowFunc,
Snapshot( *m_windowFunc)),
123 m_lsnOnClear = tr[ *m_clear].onTouch().connectWeakly(
125 m_lsnOnCondChanged = tr[ *bandWidth()].onValueChanged().connectWeakly(
127 tr[ *
autoPhase()].onValueChanged().connect(m_lsnOnCondChanged);
128 tr[ *
phase()].onValueChanged().connect(m_lsnOnCondChanged);
129 tr[ *
solverList()].onValueChanged().connect(m_lsnOnCondChanged);
130 tr[ *
windowWidth()].onValueChanged().connect(m_lsnOnCondChanged);
131 tr[ *
windowFunc()].onValueChanged().connect(m_lsnOnCondChanged);
132 tr[ *
bwList()].onValueChanged().connect(m_lsnOnCondChanged);
141 m_form->showNormal();
149 trans( *this).m_timeClearRequested = XTime::now();
155 trans( *this).m_timeClearRequested = XTime::now();
163 shared_ptr<XNMRPulseAnalyzer> pulse__ = shot_this[ *pulse()];
164 if( !pulse__)
return false;
165 if(emitter ==
this)
return true;
166 return (emitter == pulse__.get()) && checkDependencyImpl(shot_this, shot_emitter, shot_others, emitter);
171 XDriver *emitter)
throw (XRecordError&) {
174 shared_ptr<XNMRPulseAnalyzer> pulse__ = shot_this[ *pulse()];
176 const Snapshot &shot_pulse((emitter == pulse__.get()) ? shot_emitter : shot_others);
178 if(shot_pulse[ *pulse__->exAvgIncr()]) {
179 m_statusPrinter->printWarning(i18n(
"Do NOT use incremental avg. Skipping."));
180 throw XSkippedRecordError(__FILE__, __LINE__);
183 bool clear = (shot_this[ *
this].m_timeClearRequested > shot_pulse[ *pulse__].timeAwared());
186 double df = shot_pulse[ *pulse__].dFreq();
189 res = df * std::max(1L, lrint(res / df - 0.5));
195 throw XSkippedRecordError(i18n(
"Invalid min. and max."), __FILE__, __LINE__);
197 if(res * 65536 * 2 < max__ - min__) {
198 throw XSkippedRecordError(i18n(
"Too small resolution."), __FILE__, __LINE__);
201 if(fabs(log(shot_this[ *
this].res() / res)) < log(2.0))
202 res = shot_this[ *
this].res();
204 if((shot_this[ *
this].res() != res) || clear) {
205 tr[ *
this].m_res = res;
206 for(
int bank = 0; bank < Payload::ACCUM_BANKS; bank++) {
207 tr[ *
this].m_accum[bank].clear();
208 tr[ *
this].m_accum_weights[bank].clear();
209 tr[ *
this].m_accum_dark[bank].clear();
213 int diff = lrint(shot_this[ *
this].min() / res) - lrint(min__ / res);
214 for(
int bank = 0; bank < Payload::ACCUM_BANKS; bank++) {
215 auto &accum = tr[ *
this].m_accum[bank];
216 auto &accum_weights = tr[ *
this].m_accum_weights[bank];
217 auto &accum_dark = tr[ *
this].m_accum_dark[bank];
218 for(
int i = 0; i < diff; i++) {
219 accum.push_front(0.0);
220 accum_weights.push_front(0);
221 accum_dark.push_front(0.0);
223 for(
int i = 0; i < -diff; i++) {
224 if( !accum.empty()) {
226 accum_weights.pop_front();
227 accum_dark.pop_front();
232 tr[ *
this].m_min = min__;
233 int length = lrint((max__ - min__) / res);
234 for(
int bank = 0; bank < Payload::ACCUM_BANKS; bank++) {
235 tr[ *
this].m_accum[bank].resize(length, 0.0);
236 tr[ *
this].m_accum_weights[bank].resize(length, 0);
237 tr[ *
this].m_accum_dark[bank].resize(length, 0.0);
239 tr[ *
this].m_wave.resize(length);
240 std::fill(tr[ *
this].m_wave.begin(), tr[ *
this].m_wave.end(), std::complex<double>(0.0));
241 tr[ *
this].m_weights.resize(length);
242 std::fill(tr[ *
this].m_weights.begin(), tr[ *
this].m_weights.end(), 0.0);
243 tr[ *
this].m_darkPSD.resize(length);
244 std::fill(tr[ *
this].m_darkPSD.begin(), tr[ *
this].m_darkPSD.end(), 0.0);
247 tr[ *m_spectrum].clearPoints();
248 tr[ *
this].m_peaks.clear();
249 trans( *pulse__->avgClear()).touch();
250 throw XSkippedRecordError(__FILE__, __LINE__);
253 if(emitter == pulse__.get()) {
254 fssum(tr, shot_pulse, shot_others);
255 m_isInstrumControlRequested =
true;
258 m_isInstrumControlRequested =
false;
260 analyzeIFT(tr, shot_pulse);
261 std::vector<std::complex<double> > &wave(tr[ *
this].m_wave);
262 const std::vector<double> &weights(shot_this[ *
this].weights());
263 int wave_size = shot_this[ *
this].wave().size();
265 std::complex<double> csum(0.0, 0.0);
266 for(
unsigned int i = 0; i < wave_size; i++)
267 csum += wave[i] * weights[i];
268 double ph = 180.0 / M_PI * atan2(std::imag(csum), std::real(csum));
271 tr.unmark(m_lsnOnCondChanged);
273 double ph = shot_this[ *
phase()] / 180.0 * M_PI;
274 std::complex<double> cph = std::polar(1.0, -ph);
275 for(
unsigned int i = 0; i < wave_size; i++)
281 if( !shot[ *
this].time()) {
283 tr[ *m_spectrum].clearPoints();
284 tr[ *m_peakPlot->maxCount()] = 0;
289 if(m_isInstrumControlRequested.compare_set_strong((
int)
true, (
int)
false))
290 rearrangeInstrum(shot);
292 int length = shot[ *
this].wave().size();
293 std::vector<double> values;
294 getValues(shot, values);
295 assert(values.size() == length);
297 double th = FFT::windowFuncHamming(0.1);
298 const std::complex<double> *wave( &shot[ *
this].wave()[0]);
299 const double *weights( &shot[ *
this].weights()[0]);
300 const double *darkpsd( &shot[ *
this].darkPSD()[0]);
301 tr[ *m_spectrum].setRowCount(length);
302 double *colx(tr[ *m_spectrum].cols(0));
303 double *colr(tr[ *m_spectrum].cols(1));
304 double *coli(tr[ *m_spectrum].cols(2));
305 double *colw(tr[ *m_spectrum].cols(3));
306 double *colabs(tr[ *m_spectrum].cols(4));
307 double *coldark(tr[ *m_spectrum].cols(5));
308 for(
int i = 0; i < length; i++) {
310 colr[i] = std::real(wave[i]);
311 coli[i] = std::imag(wave[i]);
312 colw[i] = (weights[i] > th) ? weights[i] : 0.0;
313 colabs[i] = std::abs(wave[i]);
314 coldark[i] = sqrt(darkpsd[i]);
316 const auto &peaks(shot[ *
this].m_peaks);
317 int peaks_size = peaks.size();
318 tr[ *m_peakPlot->maxCount()] = peaks_size;
319 auto &points(tr[ *m_peakPlot].points());
320 points.resize(peaks_size);
321 for(
int i = 0; i < peaks_size; i++) {
322 double x = peaks[i].second;
323 int j = lrint(x - 0.5);
324 j = std::min(std::max(0, j), length - 2);
325 double a = values[j] + (values[j + 1] - values[j]) * (x - j);
328 m_spectrum->drawGraph(tr);
336 shared_ptr<XNMRPulseAnalyzer> pulse__ = shot_this[ *pulse()];
338 int len = shot_pulse[ *pulse__].ftWidth();
339 double df = shot_pulse[ *pulse__].dFreq();
340 if((len == 0) || (df == 0)) {
341 throw XRecordError(i18n(
"Invalid waveform."), __FILE__, __LINE__);
346 int bw = abs(lrint(shot_this[ *bandWidth()] * 1000.0 / df * 2.2));
348 throw XRecordError(i18n(
"BW beyond Nyquist freq."), __FILE__, __LINE__);
352 throw XRecordError(i18n(
"Invalid center freq."), __FILE__, __LINE__);
354 std::vector<std::complex<double> > ftwavein(len, 0.0), ftwaveout(len);
355 if( !shot_this[ *
this].m_preFFT || (shot_this[ *
this].m_preFFT->length() != len)) {
356 tr[ *
this].m_preFFT.reset(
new FFT(-1, len));
358 int wlen = std::min(len, (
int)shot_pulse[ *pulse__].wave().size());
359 int woff = -shot_pulse[ *pulse__].waveFTPos()
360 + len * ((shot_pulse[ *pulse__].waveFTPos() > 0) ? ((
int)shot_pulse[ *pulse__].waveFTPos() / len + 1) : 0);
361 const std::complex<double> *pulse_wave( &shot_pulse[ *pulse__].wave()[0]);
362 for(
int i = 0; i < wlen; i++) {
363 int j = (i + woff) % len;
364 ftwavein[j] = pulse_wave[i];
366 tr[ *
this].m_preFFT->exec(ftwavein, ftwaveout);
368 double normalize = 1.0 / (double)shot_pulse[ *pulse__].wave().size();
369 double darknormalize = shot_this[ *
this].res() / df;
370 for(
int bank = 0; bank < Payload::ACCUM_BANKS; bank++) {
371 double min = shot_this[ *
this].min();
372 double res = shot_this[ *
this].res();
373 int size = (int)shot_this[ *
this].m_accum[bank].size();
374 std::deque<std::complex<double> > &accum_wave(tr[ *
this].m_accum[bank]);
375 std::deque<double> &accum_weights(tr[ *
this].m_accum_weights[bank]);
376 std::deque<double> &accum_dark(tr[ *
this].m_accum_dark[bank]);
377 const double *pulse_dark( &shot_pulse[ *pulse__].darkPSD()[0]);
378 for(
int i = -bw / 2; i <= bw / 2; i++) {
379 double freq = i * df;
380 int idx = lrint((cfreq + freq - min) / res);
381 if((idx >= size) || (idx < 0))
383 double w = FFT::windowFuncKaiser1((
double)i / bw);
384 int j = (i + len) % len;
385 accum_wave[idx] += ftwaveout[j] * w * normalize;
386 accum_weights[idx] += w;
387 accum_dark[idx] += pulse_dark[j] * w * w * darknormalize;
396 int bank = shot_this[ *
bwList()];
397 if((bank < 0) || (bank >= Payload::ACCUM_BANKS))
398 throw XSkippedRecordError(__FILE__, __LINE__);
399 double bw_coeff = 0.5 * pow(2.0, (
double)bank);
401 double th = FFT::windowFuncHamming(0.49);
403 const std::deque<std::complex<double> > &accum_wave(shot_this[ *
this].m_accum[bank]);
404 const std::deque<double> &accum_weights(shot_this[ *
this].m_accum_weights[bank]);
405 const std::deque<double> &accum_dark(shot_this[ *
this].m_accum_dark[bank]);
406 int accum_size = accum_wave.size();
407 int min_idx = accum_size - 1;
409 for(
int i = 0; i < accum_size; i++) {
410 if(accum_weights[i] > th) {
411 min_idx = std::min(min_idx, i);
412 max_idx = std::max(max_idx, i);
416 if(max_idx <= min_idx)
417 throw XSkippedRecordError(__FILE__, __LINE__);
418 shared_ptr<XNMRPulseAnalyzer> pulse__ = shot_this[ *pulse()];
419 double res = shot_this[ *
this].res();
420 int iftlen = max_idx - min_idx + 1;
421 double wave_period = shot_pulse[ *pulse__].waveWidth() * shot_pulse[ *pulse__].interval();
423 6.0 / (res * wave_period) + 0.5);
425 int trunc2 = lrint(pow(2.0, ceil(log(iftlen * 0.03) / log(2.0))));
427 throw XSkippedRecordError(__FILE__, __LINE__);
428 iftlen = ((iftlen * 3 / 2 + npad) / trunc2 + 1) * trunc2;
429 int tdsize = lrint(wave_period * res * iftlen);
430 int iftorigin = lrint(shot_pulse[ *pulse__].waveFTPos() * shot_pulse[ *pulse__].interval() * res * iftlen);
431 int bwinv = abs(lrint(1.0 / (shot_this[ *bandWidth()] * bw_coeff * 1000.0 * shot_pulse[ *pulse__].interval() * res * iftlen)));
433 if( !shot_this[ *
this].m_ift || (shot_this[ *
this].m_ift->length() != iftlen)) {
434 tr[ *
this].m_ift.reset(
new FFT(1, iftlen));
437 std::vector<std::complex<double> > fftwave(iftlen), iftwave(iftlen);
438 std::fill(fftwave.begin(), fftwave.end(), std::complex<double>(0.0));
439 for(
int i = min_idx; i <= max_idx; i++) {
440 int k = (i - (max_idx + min_idx) / 2 + iftlen) % iftlen;
441 if(accum_weights[i] > th)
442 fftwave[k] = accum_wave[i] / accum_weights[i];
444 tr[ *
this].m_ift->exec(fftwave, iftwave);
447 std::vector<std::complex<double> > solverin;
448 FFT::twindowfunc wndfunc = m_solver->windowFunc(shot_this);
449 double wndwidth = shot_this[ *
windowWidth()] / 100.0;
450 double psdcoeff = 1.0;
452 std::vector<double> weight;
455 for(
int i = 0; i < tdsize; i++)
456 w += weight[i] * weight[i];
457 psdcoeff = w / (double)tdsize;
459 solverin.resize(iftlen);
460 double wlen = SpectrumSolver::windowLength(tdsize, -iftorigin, wndwidth);
462 wndwidth = wlen / solverin.size();
463 iftorigin = solverin.size() / 2;
466 solverin.resize(tdsize);
468 for(
int i = 0; i < (int)solverin.size(); i++) {
469 int k = (-iftorigin + i + iftlen) % iftlen;
471 solverin[i] = iftwave[k];
474 solver.exec(solverin, fftwave, -iftorigin, 0.1e-2, wndfunc, wndwidth);
477 throw XSkippedRecordError(e.msg(), __FILE__, __LINE__);
480 std::vector<std::complex<double> > &wave(tr[ *
this].m_wave);
481 std::vector<double> &weights(tr[ *
this].m_weights);
482 std::vector<double> &darkpsd(tr[ *
this].m_darkPSD);
483 psdcoeff /= wave_period;
484 for(
int i = min_idx; i <= max_idx; i++) {
485 int k = (i - (max_idx + min_idx) / 2 + iftlen) % iftlen;
486 wave[i] = fftwave[k] / (double)iftlen;
487 double w = accum_weights[i];
489 darkpsd[i] = accum_dark[i] / (w * w) * psdcoeff;
491 th = FFT::windowFuncHamming(0.1);
492 tr[ *
this].m_peaks.clear();
493 int weights_size = shot_this[ *
this].weights().size();
494 std::deque<std::pair<double, double> > &peaks(tr[ *
this].m_peaks);
495 for(
int i = 0; i < solver.peaks().size(); i++) {
496 double k = solver.peaks()[i].second;
497 double j = (k > iftlen / 2) ? (k - iftlen) : k;
498 j += (max_idx + min_idx) / 2;
500 if((l >= 0) && (l < weights_size) && (weights[l] > th))
501 peaks.emplace_back(solver.peaks()[i].first / (double)iftlen, j);