64const std::string LOG_CHARGE_NAME(
"proton_charge");
66const std::vector<std::string> binningModeNames{
"Logarithmic",
"Linear"};
70const std::vector<std::string> unitNames{
"dSpacing",
"TOF",
"MomentumTransfer"};
71enum class BinUnit { DSPACE,
TOF, Q, enum_count };
74const size_t NUM_HIST{6};
77double getFocussedPostion(
const detid_t detid,
const std::vector<double> &difc_focus) {
80 throw std::runtime_error(
"detid < 0 is not supported");
81 }
else if (detid < 100000) {
83 }
else if (detid < 200000) {
85 }
else if (detid < 300000) {
87 }
else if (detid < 400000) {
89 }
else if (detid < 500000) {
91 }
else if (detid < 600000) {
94 throw std::runtime_error(
"detid > 600000 is not supported");
98std::vector<double> calculate_difc_focused(
const double l1,
const std::vector<double> &l2s,
99 const std::vector<double> &polars) {
100 constexpr double deg2rad = std::numbers::pi_v<double> / 180.;
102 std::vector<double>
difc;
104 std::transform(l2s.cbegin(), l2s.cend(), polars.cbegin(), std::back_inserter(
difc),
105 [l1,
deg2rad](
const auto &
l2,
const auto &polar) {
106 return 1. / Kernel::Units::tofToDSpacingFactor(l1, l2, deg2rad * polar, 0.);
130 return "VULCAN ONLY Algorithm to focus powder diffraction data into a number of histograms according to a grouping "
131 "scheme defined in a CalFile.";
140 const std::vector<std::string> exts{
".nxs.h5",
".nxs",
"_event.nxs"};
143 "The name of the Event NeXus file to read, including its full or relative path. "
144 "The file name is typically of the form INST_####_event.nxs.");
148 "To only include events after the provided start time, in seconds (relative to the start of the run).");
153 "To only include events before the provided stop time, in seconds (relative to the start of the run).");
156 "Input workspace specifying \"splitters\", i.e. time intervals and targets for event filtering. "
157 "Currently only a single output workspace is supported.");
159 "Flag indicating whether in SplitterWorkspace the times are absolute or "
160 "relative. If true, they are relative to the run start time.");
163 "For development testing. Changes how the splitters are processed. If true then use ProcessBankSplitTask "
164 "otherwise loop over ProcessBankTask.");
166 "Find time-of-flight when neutron was at the sample position. This is only necessary for fast logs "
167 "(i.e. more frequent than proton on target pulse).");
170 "If true, events will be splitting using full time values (tof+pulsetime) rather than just pulsetime.");
171 auto mustBePositive = std::make_shared<BoundedValidator<int>>();
172 mustBePositive->setLower(0);
174 "Filter bad pulses in the same way that :ref:`algm-FilterBadPulses` does.");
175 auto range = std::make_shared<BoundedValidator<double>>();
176 range->setBounds(0., 100.);
178 "The percentage of the average to use as the lower bound when filtering bad pulses.");
179 const std::vector<std::string> cal_exts{
".h5",
".hd5",
".hdf",
".cal"};
181 "The .cal file containing the position correction factors. Either this or OffsetsWorkspace needs to "
183 auto mustBePosArr = std::make_shared<Kernel::ArrayBoundedValidator<double>>();
184 mustBePosArr->setLower(0.0);
186 "Minimum x-value for the output binning");
188 "Bin size for output data");
190 "Minimum x-value for the output binning");
192 "The units of the input X min, max and delta values. Output will always be TOF");
194 "Specify binning behavior ('Logarithmic')");
196 "If specified, only these logs will be loaded from the file");
198 "If specified, these logs will not be loaded from the file");
201 "An output workspace.");
204 const std::string CHUNKING_PARAM_GROUP(
"Chunking-temporary");
205 auto positiveIntValidator = std::make_shared<Mantid::Kernel::BoundedValidator<int>>();
206 positiveIntValidator->setLower(1);
208 positiveIntValidator),
209 "Number of elements of time-of-flight or detector-id to read at a time. This is a maximum");
213 "Number of events to read in a single thread. Higher means less threads are created.");
218 positiveIntValidator),
219 "The bank for which to read data; if specified, others will be blank");
223 std::map<std::string, std::string> errors;
228 if (disk_chunk < grainsize_events) {
240 const auto numMin = xmins.size();
241 const auto numMax = xmaxs.size();
242 const auto numDelta = deltas.size();
244 if (std::any_of(deltas.cbegin(), deltas.cend(), [](
double d) { return !std::isfinite(d) || d == 0; }))
246 else if (!(numDelta == 1 || numDelta == NUM_HIST))
249 if (!(numMin == 1 || numMin == NUM_HIST))
252 if (!(numMax == 1 || numMax == NUM_HIST))
274 this->
progress(.0,
"Create output workspace");
281 if (filename.find(
"VULCAN") == std::string::npos) {
282 throw std::runtime_error(
"File does not appear to be for VULCAN");
288 const std::string ENTRY_TOP_LEVEL(
"entry");
289 LoadEventNexus::loadInstrument<MatrixWorkspace_sptr>(filename, wksp, ENTRY_TOP_LEVEL,
this, &descriptor);
292 const double l1{43.755};
293 const std::vector<double> polars{90, 90, 120, 150, 157, 65.5};
294 const std::vector<double> azimuthals{180, 0, 0, 0, 0, 0};
295 const std::vector<double> l2s{2.296, 2.296, 2.070, 2.070, 2.070, 2.530};
296 const std::vector<specnum_t> specids;
297 const auto difc_focused = calculate_difc_focused(l1, l2s, polars);
300 this->
progress(.05,
"Creating calibration constants");
302 if (!cal_filename.empty()) {
303 this->
loadCalFile(wksp, cal_filename, difc_focused);
314 this->
progress(.07,
"Set instrument geometry");
318 this->
progress(.1,
"Convert bins to TOF");
331 this->
progress(.11,
"Loading metadata");
335 }
catch (std::exception &e) {
336 g_log.
warning() <<
"Error while loading meta data: " << e.what() <<
'\n';
340 this->
progress(.12,
"Loading logs");
341 auto periodLog = std::make_unique<const TimeSeriesProperty<int>>(
"period_log");
345 LoadEventNexus::runLoadNexusLogs<MatrixWorkspace_sptr>(filename, wksp, *
this,
false, nPeriods, periodLog, allow_logs,
351 this->
progress(.15,
"Determining pulse indices");
354 const std::map<std::string, std::set<std::string>> &allEntries = descriptor.
getAllEntries();
355 auto itClassEntries = allEntries.find(
"NXevent_data");
359 if (itClassEntries == allEntries.end()) {
361 throw std::runtime_error(
"No NXevent_data entries found in file");
364 this->
progress(.17,
"Reading events");
367 std::vector<std::string> bankEntryNames;
368 std::size_t num_banks_to_read;
371 for (
size_t i = 1; i <= NUM_HIST; ++i) {
374 num_banks_to_read = NUM_HIST;
377 for (
size_t i = 1; i <= NUM_HIST; ++i) {
378 bankEntryNames.push_back(
"");
381 bankEntryNames[outputSpecNum - 1] =
"bank" +
std::to_string(outputSpecNum) +
"_events";
382 num_banks_to_read = 1;
388 g_log.
debug() << (DISK_CHUNK / GRAINSIZE_EVENTS) <<
" threads per chunk\n";
390 if (timeSplitter.empty()) {
393 auto progress = std::make_shared<API::Progress>(
this, .17, .9, num_banks_to_read);
395 static_cast<size_t>(DISK_CHUNK),
static_cast<size_t>(GRAINSIZE_EVENTS), pulse_indices,
398 if (num_banks_to_read > 1) {
399 tbb::parallel_for(tbb::blocked_range<size_t>(0, num_banks_to_read), task);
402 task(tbb::blocked_range<size_t>(outputSpecNum - 1, outputSpecNum));
409 wksp->mutableRun().setTimeROI(filterROI);
410 wksp->mutableRun().removeDataOutsideTimeROI();
415 std::vector<std::string> wsNames;
416 std::vector<int> workspaceIndices;
417 std::vector<MatrixWorkspace_sptr> workspaces;
418 for (
const int &splitter_target : timeSplitter.outputWorkspaceIndices()) {
419 std::string ws_name = ws_basename +
"_" + timeSplitter.getWorkspaceIndexName(splitter_target);
420 wsNames.push_back(std::move(ws_name));
421 workspaceIndices.push_back(splitter_target);
422 workspaces.emplace_back(wksp->clone());
425 auto progress = std::make_shared<API::Progress>(
this, .17, .9, num_banks_to_read * workspaceIndices.size());
427 g_log.
information() <<
"Using ProcessBankSplitFullTimeTask for splitter processing\n";
432 if (!filterROI.useAll()) {
433 combined_time_roi.update_intersection(filterROI);
438 const auto &splitterMap = timeSplitter.getSplittersMap();
442 static_cast<size_t>(GRAINSIZE_EVENTS), pulse_indices, splitterMap,
progress);
445 if (num_banks_to_read > 1) {
446 tbb::parallel_for(tbb::blocked_range<size_t>(0, num_banks_to_read), task);
449 task(tbb::blocked_range<size_t>(outputSpecNum - 1, outputSpecNum));
453 g_log.
information() <<
"Using ProcessBankSplitTask for splitter processing\n";
459 static_cast<size_t>(GRAINSIZE_EVENTS), target_to_pulse_indices,
progress);
461 if (num_banks_to_read > 1) {
462 tbb::parallel_for(tbb::blocked_range<size_t>(0, num_banks_to_read), task);
465 task(tbb::blocked_range<size_t>(outputSpecNum - 1, outputSpecNum));
471 tbb::blocked_range<size_t>(0, workspaceIndices.size()),
472 [&](
const tbb::blocked_range<size_t> &target_indices) {
473 for (size_t target_index = target_indices.begin(); target_index != target_indices.end(); ++target_index) {
474 const int splitter_target = workspaceIndices[target_index];
476 auto splitter_roi = timeSplitter.getTimeROI(splitter_target);
478 auto target_roi = filterROI;
479 if (target_roi.useAll())
480 target_roi = std::move(splitter_roi);
481 else if (!splitter_roi.useAll())
482 target_roi.update_intersection(splitter_roi);
485 MatrixWorkspace_sptr target_wksp = workspaces[target_index];
487 const auto pulse_indices = this->determinePulseIndices(target_wksp, target_roi);
489 ProcessBankTask task(bankEntryNames, h5file, is_time_filtered, target_wksp, m_calibration,
490 m_scale_at_sample, m_masked, static_cast<size_t>(DISK_CHUNK),
491 static_cast<size_t>(GRAINSIZE_EVENTS), pulse_indices, progress);
493 if (num_banks_to_read > 1) {
494 tbb::parallel_for(tbb::blocked_range<size_t>(0, num_banks_to_read), task);
497 task(tbb::blocked_range<size_t>(outputSpecNum - 1, outputSpecNum));
507 for (
size_t idx = 0; idx < workspaceIndices.size(); ++idx) {
509 auto target_roi = timeSplitter.getTimeROI(workspaceIndices[idx]);
510 if (target_roi.useAll())
511 target_roi = filterROI;
512 else if (!filterROI.useAll())
513 target_roi.update_intersection(filterROI);
516 workspaces[idx]->mutableRun().setTimeROI(target_roi);
517 workspaces[idx]->mutableRun().removeDataOutsideTimeROI();
518 AnalysisDataService::Instance().addOrReplace(wsNames[idx], workspaces[idx]);
523 groupws->setAlwaysStoreInADS(
true);
524 groupws->setProperty(
"InputWorkspaces", wsNames);
525 groupws->setProperty(
"OutputWorkspace", ws_basename);
528 if (!groupws->isExecuted()) {
529 throw std::runtime_error(
"Failed to group output workspaces");
541 const bool linearBins = bool(binmode == BinningMode::LINEAR);
542 const std::string binUnits = getPropertyValue(PropertyNames::BIN_UNITS);
543 std::vector<double> x_delta = getProperty(PropertyNames::X_DELTA);
544 std::vector<double> x_min = getProperty(PropertyNames::X_MIN);
545 std::vector<double> x_max = getProperty(PropertyNames::X_MAX);
546 const bool raggedBins = (x_delta.size() != 1 || x_min.size() != 1 || x_max.size() != 1);
548 constexpr bool resize_xnew{
true};
549 constexpr bool full_bins_only{
false};
552 HistogramData::BinEdges XValues(0);
554 const std::vector<double> params{x_min[0], x_delta[0], x_max[0]};
558 const std::vector<double> params{x_min[0], -1. * x_delta[0], x_max[0]};
566 if (x_delta.size() == 1)
567 x_delta.resize(NUM_HIST, x_delta[0]);
568 if (x_min.size() == 1)
569 x_min.resize(NUM_HIST, x_min[0]);
570 if (x_max.size() == 1)
571 x_max.resize(NUM_HIST, x_max[0]);
573 for (
size_t i = 1; i < NUM_HIST; ++i) {
574 HistogramData::BinEdges XValues_new(0);
577 const std::vector<double> params{x_min[i], x_delta[i], x_max[i]};
581 const std::vector<double> params{x_min[i], -1. * x_delta[i], x_max[i]};
585 HistogramData::Histogram hist(XValues_new, HistogramData::Counts(XValues_new.size() - 1, 0.0));
586 wksp->setHistogram(i, hist);
590 wksp->getAxis(0)->setUnit(binUnits);
591 wksp->setYUnit(
"Counts");
597 const std::vector<double> &difc_focus) {
598 const auto detInfo = wksp->detectorInfo();
600 for (
auto iter = detInfo.cbegin(); iter != detInfo.cend(); ++iter) {
601 if (!iter->isMonitor()) {
602 const auto difc_focussed = getFocussedPostion(
static_cast<detid_t>(iter->detid()), difc_focus);
603 m_calibration.emplace(
static_cast<detid_t>(iter->detid()),
604 difc_focussed / detInfo.difcUncalibrated(iter->index()));
610 const std::vector<double> &difc_focus) {
611 auto alg = createChildAlgorithm(
"LoadDiffCal");
612 alg->setProperty(
"InputWorkspace", inputWS);
613 alg->setPropertyValue(
"Filename", filename);
614 alg->setProperty<
bool>(
"MakeCalWorkspace",
true);
615 alg->setProperty<
bool>(
"MakeGroupingWorkspace",
false);
616 alg->setProperty<
bool>(
"MakeMaskWorkspace",
true);
617 alg->setPropertyValue(
"WorkspaceName",
"temp");
618 alg->executeAsChildAlg();
621 for (
size_t row = 0; row < calibrationWS->rowCount(); ++row) {
622 const detid_t detid = calibrationWS->cell<
int>(row, 0);
623 const double detc = calibrationWS->cell<
double>(row, 1);
624 const auto difc_focussed = getFocussedPostion(detid, difc_focus);
625 m_calibration.emplace(detid, difc_focussed / detc);
629 m_masked = maskWS->getMaskedDetectors();
630 g_log.
debug() <<
"Masked detectors: " << m_masked.size() <<
'\n';
639 const auto detInfo = wksp->detectorInfo();
641 const double L1 = detInfo.l1();
643 if (this->getProperty(PropertyNames::CORRECTION_TO_SAMPLE)) {
645 for (
auto iter = detInfo.cbegin(); iter != detInfo.cend(); ++iter) {
646 if (!iter->isMonitor()) {
647 const double path_correction = L1 / (L1 + iter->l2()) * 1000.0;
648 m_scale_at_sample.emplace(
static_cast<detid_t>(iter->detid()), path_correction);
653 for (
auto iter = detInfo.cbegin(); iter != detInfo.cend(); ++iter) {
654 if (!iter->isMonitor()) {
655 m_scale_at_sample.emplace(
static_cast<detid_t>(iter->detid()), 1000.0);
663 const std::vector<specnum_t> &specids,
const std::vector<double> &l2s,
const std::vector<double> &azimuthals) {
665 editAlg->setLoggingOffset(1);
666 editAlg->setProperty(
"Workspace", wksp);
668 editAlg->setProperty(
"PrimaryFlightPath", l1);
670 editAlg->setProperty(
"Polar", polars);
671 if (!specids.empty())
672 editAlg->setProperty(
"SpectrumIDs", specids);
674 editAlg->setProperty(
"L2", l2s);
675 if (!azimuthals.empty())
676 editAlg->setProperty(
"Azimuthal", azimuthals);
677 editAlg->executeAsChildAlg();
679 wksp = editAlg->getProperty(
"Workspace");
685 if (wksp->getAxis(0)->unit()->unitID() ==
"TOF") {
691 convertUnits->setProperty(
"InputWorkspace", wksp);
692 convertUnits->setPropertyValue(
"Target",
"TOF");
693 convertUnits->executeAsChildAlg();
694 wksp = convertUnits->getProperty(
"OutputWorkspace");
708 const auto startOfRun = wksp->run().startTime();
711 double filter_time_start_sec = getProperty(PropertyNames::FILTER_TIMESTART);
712 double filter_time_stop_sec = getProperty(PropertyNames::FILTER_TIMESTOP);
714 this->progress(.15,
"Creating time filtering");
715 g_log.
information() <<
"Filtering pulses from " << filter_time_start_sec <<
" to " << filter_time_stop_sec <<
"s\n";
718 roi.
addROI(startOfRun + (filter_time_start_sec ==
EMPTY_DBL() ? 0.0 : filter_time_start_sec),
719 startOfRun + filter_time_stop_sec);
720 }
catch (
const std::runtime_error &e) {
721 throw std::invalid_argument(
"Invalid time range for filtering: " + std::string(e.what()));
726 if (getProperty(PropertyNames::FILTER_BAD_PULSES)) {
727 this->progress(.16,
"Filtering bad pulses");
730 const auto [min_pcharge, max_pcharge, mean] =
731 wksp->run().getBadPulseRange(LOG_CHARGE_NAME, getProperty(PropertyNames::FILTER_BAD_PULSES_LOWER_CUTOFF));
732 g_log.
information() <<
"Filtering bad pulses; pcharge outside of " << min_pcharge <<
" to " << max_pcharge <<
'\n';
734 const auto run_start = wksp->getFirstPulseTime();
735 const auto run_stop = wksp->getLastPulseTime();
757 std::vector<PulseROI> pulse_indices;
759 pulse_indices.emplace_back(0, std::numeric_limits<size_t>::max());
761 is_time_filtered =
true;
765 if (!frequency_log) {
766 throw std::runtime_error(
"Frequency log not found in workspace run");
768 const auto pulse_times =
769 std::make_unique<std::vector<Mantid::Types::Core::DateAndTime>>(frequency_log->timesAsVector());
772 if (pulse_indices.empty())
773 throw std::invalid_argument(
"No valid pulse time indices found for filtering");
776 return pulse_indices;
788std::vector<std::pair<int, PulseROI>>
793 if (!frequency_log) {
794 throw std::runtime_error(
"Frequency log not found in workspace run");
796 const auto pulse_times =
797 std::make_unique<std::vector<Mantid::Types::Core::DateAndTime>>(frequency_log->timesAsVector());
799 std::vector<PulseROI> pulse_indices;
801 pulse_indices.emplace_back(0, std::numeric_limits<size_t>::max());
804 if (pulse_indices.empty())
805 throw std::invalid_argument(
"No valid pulse time indices found for filtering");
811 std::vector<std::pair<int, PulseROI>> intersected_target_pulse_indices;
812 auto pulse_it = pulse_indices.cbegin();
813 for (
const auto &target_pair : target_to_pulse_indices) {
815 while (pulse_it != pulse_indices.cend() && pulse_it->second <= target_pair.second.first) {
819 auto check_it = pulse_it;
820 while (check_it != pulse_indices.cend() && check_it->first < target_pair.second.second) {
822 size_t start_index = std::max(check_it->first, target_pair.second.first);
823 size_t stop_index = std::min(check_it->second, target_pair.second.second);
824 if (start_index < stop_index) {
825 intersected_target_pulse_indices.emplace_back(target_pair.first,
PulseROI(start_index, stop_index));
831 return intersected_target_pulse_indices;
835AlignAndFocusPowderSlim::timeSplitterFromSplitterWorkspace(
const Types::Core::DateAndTime &filterStartTime) {
838 std::dynamic_pointer_cast<DataObjects::SplittersWorkspace>(tempws);
840 std::dynamic_pointer_cast<DataObjects::TableWorkspace>(tempws);
843 if (!splittersWorkspace && !splitterTableWorkspace && !matrixSplitterWS)
846 const bool isSplittersRelativeTime = this->getProperty(PropertyNames::SPLITTER_RELATIVE);
849 if (splittersWorkspace) {
851 }
else if (splitterTableWorkspace) {
853 TimeSplitter(splitterTableWorkspace, isSplittersRelativeTime ? filterStartTime : DateAndTime::GPS_EPOCH);
855 time_splitter =
TimeSplitter(matrixSplitterWS, isSplittersRelativeTime ? filterStartTime : DateAndTime::GPS_EPOCH);
858 return time_splitter;
#define DECLARE_ALGORITHM(classname)
#define UNUSED_ARG(x)
Function arguments are sometimes unused in certain implmentations but are required for documentation ...
void declareProperty(std::unique_ptr< Kernel::Property > p, const std::string &doc="") override
Add a property to the list of managed properties.
std::string getPropertyValue(const std::string &name) const override
Get the value of a property as a string.
TypedValue getProperty(const std::string &name) const override
Get the value of a property.
virtual std::shared_ptr< Algorithm > createChildAlgorithm(const std::string &name, const double startProgress=-1., const double endProgress=-1., const bool enableLogging=true, const int &version=-1)
Create a Child Algorithm.
void progress(double p, const std::string &msg="", double estimatedTime=0.0, int progressPrecision=0)
Sends ProgressNotification.
bool isDefault(const std::string &name) const
A specialized class for dealing with file properties.
@ OptionalLoad
to specify a file to read but the file doesn't have to exist
@ Load
allowed here which will be passed to the algorithm
A property class for workspaces.
Base Workspace Abstract Class.
AlignAndFocusPowderSlim : TODO: DESCRIPTION.
std::vector< int64_t > loadSize
How much to load in the file.
const std::string summary() const override
Algorithm's summary for use in the GUI and help.
std::map< std::string, std::string > validateInputs() override
Perform validation of ALL the input properties of the algorithm.
std::vector< int64_t > loadStart
Index to load start at in the file.
std::map< detid_t, double > m_calibration
detid: 1/difc
void init() override
Initialize the algorithm's properties.
std::set< detid_t > m_masked
DataObjects::TimeSplitter timeSplitterFromSplitterWorkspace(const Types::Core::DateAndTime &)
std::map< detid_t, double > m_scale_at_sample
Multiplicative 0<value<1 to move neutron TOF at sample.
void initScaleAtSample(const API::MatrixWorkspace_sptr &wksp)
For fast logs, calculate the sample position correction.
const std::string category() const override
Algorithm's category for identification.
static std::vector< std::pair< int, std::pair< size_t, size_t > > > determinePulseIndicesTargets(const API::MatrixWorkspace_sptr &wksp, const Kernel::TimeROI &filterROI, const DataObjects::TimeSplitter &timeSplitter)
Determine the pulse indices for a given workspace, time ROI, and time splitter.
API::MatrixWorkspace_sptr createOutputWorkspace()
API::MatrixWorkspace_sptr editInstrumentGeometry(API::MatrixWorkspace_sptr &wksp, const double l1, const std::vector< double > &polars, const std::vector< specnum_t > &specids, const std::vector< double > &l2s, const std::vector< double > &azimuthals)
std::vector< std::pair< size_t, size_t > > determinePulseIndices(const API::MatrixWorkspace_sptr &wksp, const Kernel::TimeROI &filterROI)
Determine the pulse indices for a given workspace and time ROI.
int version() const override
Algorithm's version for identification.
const std::vector< std::string > seeAlso() const override
Function to return all of the seeAlso (these are not validated) algorithms related to this algorithm....
void loadCalFile(const API::Workspace_sptr &inputWS, const std::string &filename, const std::vector< double > &difc_focus)
Kernel::TimeROI getFilterROI(const API::MatrixWorkspace_sptr &wksp)
Create a TimeROI based on the filtering properties set in the algorithm.
API::MatrixWorkspace_sptr convertToTOF(API::MatrixWorkspace_sptr &wksp)
void exec() override
Execute the algorithm.
void initCalibrationConstants(API::MatrixWorkspace_sptr &wksp, const std::vector< double > &difc_focus)
static void loadEntryMetadata(const std::string &nexusfilename, T WS, const std::string &entry_name, const Nexus::NexusDescriptor &descriptor)
Load the run number and other meta data from the given bank.
std::vector< std::pair< int, std::pair< size_t, size_t > > > calculate_target_indices(const std::vector< DateAndTime > ×) const
Given a list of times, calculate the corresponding indices in the TimeSplitter.
Concrete workspace implementation.
Kernel/ArrayBoundedValidator.h.
Support for a property that holds an array of values.
BoundedValidator is a validator that requires the values to be between upper or lower bounds,...
A concrete property based on user options of a finite list of strings.
IPropertyManager * setProperty(const std::string &name, const T &value)
Templated method to set the value of a PropertyWithValue.
void setPropertyGroup(const std::string &name, const std::string &group)
Set the group for a given property.
void debug(const std::string &msg)
Logs at debug level.
void warning(const std::string &msg)
Logs at warning level.
void information(const std::string &msg)
Logs at information level.
The concrete, templated class for properties.
Represents a time interval.
TimeROI : Object that holds information about when the time measurement was active.
std::vector< std::pair< size_t, size_t > > calculate_indices(const std::vector< Types::Core::DateAndTime > ×) const
void addROI(const std::string &startTime, const std::string &stopTime)
bool useAll() const
TimeROI selects all time to be used.
A specialised Property class for holding a series of time-value pairs.
const std::map< std::string, std::set< std::string > > & getAllEntries() const noexcept
Returns a const reference of the internal map holding all entries in the Nexus HDF5 file.
std::shared_ptr< IAlgorithm > IAlgorithm_sptr
shared pointer to Mantid::API::IAlgorithm
std::shared_ptr< ITableWorkspace > ITableWorkspace_sptr
shared pointer to Mantid::API::ITableWorkspace
std::shared_ptr< Workspace > Workspace_sptr
shared pointer to Mantid::API::Workspace
Mantid::Kernel::SingletonHolder< AnalysisDataServiceImpl > AnalysisDataService
Kernel::Logger g_log("ExperimentInfo")
static logger object
std::shared_ptr< MatrixWorkspace > MatrixWorkspace_sptr
shared pointer to the matrix workspace base class
const std::string FILTER_TIMESTART("FilterByTimeStart")
const std::string CAL_FILE("CalFileName")
const std::string FILTER_BAD_PULSES_LOWER_CUTOFF("BadPulsesLowerCutoff")
const std::string OUTPUT_SPEC_NUM("OutputSpectrumNumber")
const std::string ALLOW_LOGS("LogAllowList")
const std::string SPLITTER_RELATIVE("RelativeTime")
const std::string PROCESS_BANK_SPLIT_TASK("ProcessBankSplitTask")
const std::string OUTPUT_WKSP("OutputWorkspace")
const std::string CORRECTION_TO_SAMPLE("CorrectionToSample")
const std::string BIN_UNITS("BinningUnits")
const std::string FILTER_TIMESTOP("FilterByTimeStop")
const std::string BLOCK_LOGS("LogBlockList")
const std::string X_DELTA("XDelta")
const std::string X_MIN("XMin")
const std::string FILENAME("Filename")
const std::string BINMODE("BinningMode")
const std::string SPLITTER_WS("SplitterWorkspace")
const std::string EVENTS_PER_THREAD("EventsPerThread")
const std::string FILTER_BAD_PULSES("FilterBadPulses")
const std::string X_MAX("XMax")
const std::string FULL_TIME("UseFullTime")
const std::string READ_SIZE_FROM_DISK("ReadSizeFromDisk")
std::pair< size_t, size_t > PulseROI
const int64_t PULSETIME_OFFSET
std::shared_ptr< SplittersWorkspace > SplittersWorkspace_sptr
std::shared_ptr< TableWorkspace > TableWorkspace_sptr
shared pointer to Mantid::DataObjects::TableWorkspace
std::shared_ptr< MaskWorkspace > MaskWorkspace_sptr
shared pointer to the MaskWorkspace class
constexpr double deg2rad
Defines units/enum for Crystal work.
int MANTID_KERNEL_DLL createAxisFromRebinParams(const std::vector< double > ¶ms, std::vector< double > &xnew, const bool resize_xnew=true, const bool full_bins_only=false, const double xMinHint=std::nan(""), const double xMaxHint=std::nan(""), const bool useReverseLogarithmic=false, const double power=-1)
Creates a new output X array given a 'standard' set of rebinning parameters.
MANTID_NEXUS_DLL H5::FileAccPropList defaultFileAcc()
Default file access is H5F_CLOSE_STRONG.
const std::string BINMODE("BinningMode")
constexpr int EMPTY_INT() noexcept
Returns what we consider an "empty" integer within a property.
int32_t detid_t
Typedef for a detector ID.
constexpr double EMPTY_DBL() noexcept
Returns what we consider an "empty" double within a property.
std::string to_string(const wide_integer< Bits, Signed > &n)
Describes the direction (within an algorithm) of a Property.
@ Input
An input workspace.
@ Output
An output workspace.