BornAgain
1.19.0
Simulate and fit neutron and x-ray scattering at grazing incidence
|
Abstract 2D detector interface. More...
Public Types | |
using | const_iterator = const SimulationAreaIterator & |
Public Member Functions | |
IDetector2D () | |
virtual | ~IDetector2D () |
virtual void | accept (INodeVisitor *visitor) const =0 |
Calls the INodeVisitor's visit method. More... | |
std::vector< size_t > | active_indices () const |
Returns vector of unmasked detector indices. More... | |
void | addAxis (const IAxis &axis) |
void | addMask (const IShape2D &shape, bool mask_value=true) |
Adds mask of given shape to the stack of detector masks. More... | |
void | applyDetectorResolution (OutputData< double > *p_intensity_map) const |
Applies the detector resolution to the given intensity maps. More... | |
const IAxis & | axis (size_t index) const |
size_t | axisBinIndex (size_t index, size_t selected_axis) const |
Calculate axis index for given global index. More... | |
IDetector2D * | clone () const override=0 |
int | copyNumber (const INode *node) const |
Returns copyNumber of child, which takes into account existence of children with same name. More... | |
std::unique_ptr< DetectorContext > | createContext () const |
OutputData< double > * | createDetectorIntensity (const std::vector< SimulationElement > &elements) const |
Returns new intensity map with detector resolution applied. More... | |
std::unique_ptr< OutputData< double > > | createDetectorMap () const |
Returns empty detector map in given axes units. More... | |
ParameterPool * | createParameterTree () const |
Creates new parameter pool, with all local parameters and those of its children. More... | |
virtual IPixel * | createPixel (size_t index) const =0 |
Creates an IPixel for the given OutputData object and index. More... | |
virtual Axes::Units | defaultAxesUnits () const |
Return default axes units. More... | |
const DetectionProperties & | detectionProperties () const |
Returns detection properties. More... | |
const DetectorMask * | detectorMask () const override |
Returns detector masks container. More... | |
const IDetectorResolution * | detectorResolution () const |
Returns a pointer to detector resolution object. More... | |
size_t | dimension () const |
Returns actual dimensionality of the detector (number of defined axes) More... | |
std::string | displayName () const |
Returns display name, composed from the name of node and it's copy number. More... | |
std::vector< const INode * > | getChildren () const override |
Returns a vector of children. More... | |
const std::string & | getName () const |
virtual size_t | indexOfSpecular (const Beam &beam) const =0 |
Returns index of pixel that contains the specular wavevector. More... | |
virtual void | init (const Beam &) |
Inits detector with the beam settings. More... | |
void | iterate (std::function< void(const_iterator)> func, bool visit_masks=false) const |
void | maskAll () |
Put the mask for all detector channels (i.e. exclude whole detector from the analysis) More... | |
size_t | numberOfSimulationElements () const |
Returns number of simulation elements. More... | |
virtual void | onChange () |
Action to be taken in inherited class when a parameter has changed. More... | |
RealParameter * | parameter (const std::string &name) const |
Returns parameter with given 'name'. More... | |
ParameterPool * | parameterPool () const |
Returns pointer to the parameter pool. More... | |
std::string | parametersToString () const |
Returns multiline string representing available parameters. More... | |
INode * | parent () |
const INode * | parent () const |
std::vector< const INode * > | progeny () const |
Returns a vector of all descendants. More... | |
const RegionOfInterest * | regionOfInterest () const override |
Returns region of interest if exists. More... | |
void | registerChild (INode *node) |
RealParameter & | registerParameter (const std::string &name, double *parpointer) |
void | registerVector (const std::string &base_name, kvector_t *p_vec, const std::string &units="nm") |
void | removeParameter (const std::string &name) |
void | removeVector (const std::string &base_name) |
void | resetRegionOfInterest () override |
Resets region of interest making whole detector plane available for the simulation. More... | |
void | setAnalyzerProperties (const kvector_t direction, double efficiency, double total_transmission) |
Sets the polarization analyzer characteristics of the detector. More... | |
void | setDetectorParameters (size_t n_x, double x_min, double x_max, size_t n_y, double y_min, double y_max) |
Sets detector parameters using angle ranges. More... | |
void | setDetectorResolution (const IDetectorResolution &p_detector_resolution) |
Sets the detector resolution. More... | |
void | setName (const std::string &name) |
void | setParameterValue (const std::string &name, double value) |
virtual void | setParent (const INode *newParent) |
void | setRegionOfInterest (double xlow, double ylow, double xup, double yup) |
Sets rectangular region of interest with lower left and upper right corners defined. More... | |
void | setResolutionFunction (const IResolutionFunction2D &resFunc) |
void | setVectorValue (const std::string &base_name, kvector_t value) |
size_t | totalSize () const |
Returns total number of pixels. More... | |
virtual void | transferToCPP () |
Used for Python overriding of clone (see swig/tweaks.py) More... | |
virtual std::string | treeToString () const |
Returns multiline string representing tree structure below the node. More... | |
Static Public Member Functions | |
static std::string | XComponentName (const std::string &base_name) |
static std::string | YComponentName (const std::string &base_name) |
static std::string | ZComponentName (const std::string &base_name) |
Protected Member Functions | |
IDetector2D (const IDetector2D &other) | |
virtual std::string | axisName (size_t index) const =0 |
Returns the name for the axis with given index. More... | |
void | clear () |
virtual std::unique_ptr< IAxis > | createAxis (size_t index, size_t n_bins, double min, double max) const |
Generates an axis with correct name and default binning for given index. More... | |
size_t | getGlobalIndex (size_t x, size_t y) const |
Calculate global index from two axis indices. More... | |
Protected Attributes | |
const size_t | m_NP |
std::vector< double > | m_P |
Private Member Functions | |
void | setDataToDetectorMap (OutputData< double > &detectorMap, const std::vector< SimulationElement > &elements) const |
Private Attributes | |
CloneableVector< IAxis > | m_axes |
DetectionProperties | m_detection_properties |
DetectorMask | m_detector_mask |
std::unique_ptr< IDetectorResolution > | m_detector_resolution |
std::string | m_name |
const INode * | m_parent {nullptr} |
std::unique_ptr< ParameterPool > | m_pool |
parameter pool (kind of pointer-to-implementation) More... | |
std::unique_ptr< RegionOfInterest > | m_region_of_interest |
Abstract 2D detector interface.
Definition at line 31 of file IDetector2D.h.
|
inherited |
Definition at line 38 of file IDetector.h.
|
default |
|
virtualdefault |
|
protected |
Definition at line 26 of file IDetector2D.cpp.
References RegionOfInterest::clone(), m_region_of_interest, and regionOfInterest().
|
pure virtualinherited |
Calls the INodeVisitor's visit method.
Implemented in FormFactorDecoratorMaterial, FormFactorWeighted, FormFactorCrystal, FormFactorCoreShell, Lattice3D, MisesGaussPeakShape, MisesFisherGaussPeakShape, LorentzFisherPeakShape, GaussFisherPeakShape, IsotropicLorentzPeakShape, IsotropicGaussPeakShape, ParticleLayout, InterferenceFunctionHardDisk, InterferenceFunctionFinite3DLattice, InterferenceFunctionFinite2DLattice, InterferenceFunction3DLattice, InterferenceFunction2DSuperLattice, InterferenceFunction2DParaCrystal, InterferenceFunction2DLattice, InterferenceFunction1DLattice, SphericalDetector, SpecularDetector1D, FootprintSquare, FootprintGauss, Beam, OffSpecularSimulation, GISASSimulation, PoissonNoiseBackground, ConstantBackground, FormFactorSphereLogNormalRadius, FormFactorSphereGaussianRadius, FormFactorGaussSphere, FormFactorDecoratorRotation, FormFactorDecoratorPositionFactor, SampleProvider, SampleBuilderNode, ParticleDistribution, ParticleCoreShell, ParticleComposition, Particle, MesoCrystal, Crystal, MultiLayer, Layer, HexagonalLattice2D, SquareLattice2D, BasicLattice2D, FormFactorTruncatedSpheroid, FormFactorTruncatedSphere, FormFactorTruncatedCube, FormFactorTetrahedron, FormFactorSawtoothRippleLorentz, FormFactorSawtoothRippleGauss, FormFactorSawtoothRippleBox, FormFactorPyramid, FormFactorPrism6, FormFactorPrism3, FormFactorLongBoxLorentz, FormFactorLongBoxGauss, FormFactorIcosahedron, FormFactorHollowSphere, FormFactorHemiEllipsoid, FormFactorFullSpheroid, FormFactorFullSphere, FormFactorEllipsoidalCylinder, FormFactorDot, FormFactorDodecahedron, FormFactorCylinder, FormFactorCuboctahedron, FormFactorCosineRippleLorentz, FormFactorCosineRippleGauss, FormFactorCosineRippleBox, FormFactorCone6, FormFactorCone, FormFactorCantellatedCube, FormFactorBox, FormFactorBarLorentz, FormFactorBarGauss, FormFactorAnisoPyramid, FTDistribution2DVoigt, FTDistribution2DCone, FTDistribution2DGate, FTDistribution2DGauss, FTDistribution2DCauchy, FTDistribution1DVoigt, FTDistribution1DCosine, FTDistribution1DTriangle, FTDistribution1DGate, FTDistribution1DGauss, FTDistribution1DCauchy, FTDecayFunction2DVoigt, FTDecayFunction2DGauss, FTDecayFunction2DCauchy, FTDecayFunction1DVoigt, FTDecayFunction1DTriangle, FTDecayFunction1DGauss, FTDecayFunction1DCauchy, InterferenceFunctionTwin, InterferenceFunctionRadialParaCrystal, InterferenceFunctionNone, DistributionTrapezoid, DistributionCosine, DistributionLogNormal, DistributionGaussian, DistributionLorentz, DistributionGate, ResolutionFunction2DGaussian, ConvolutionDetectorResolution, Instrument, RectangularDetector, IsGISAXSDetector, DetectionProperties, SpecularSimulation, DepthProbeSimulation, LayerRoughness, LayerInterface, RotationEuler, RotationZ, RotationY, RotationX, IdentityRotation, and IAbstractParticle.
std::vector< size_t > IDetector2D::active_indices | ( | ) | const |
Returns vector of unmasked detector indices.
Definition at line 60 of file IDetector2D.cpp.
References SimulationArea::begin(), and SimulationArea::end().
Referenced by DetectorContext::setup_context().
|
inherited |
Definition at line 41 of file IDetector.cpp.
References IDetector::axis(), IAxis::clone(), IDetector::m_axes, and CloneableVector< T >::push_back().
Referenced by SpecularDetector1D::SpecularDetector1D(), SpecularDetector1D::setAxis(), setDetectorParameters(), and SpecularSimulation::setScan().
void IDetector2D::addMask | ( | const IShape2D & | shape, |
bool | mask_value = true |
||
) |
Adds mask of given shape to the stack of detector masks.
The mask value 'true' means that the channel will be excluded from the simulation. The mask which is added last has priority.
Definition at line 74 of file IDetector2D.cpp.
References DetectorMask::addMask(), DetectorMask::initMaskData(), and m_detector_mask.
Referenced by ISimulation2D::addMask(), DetectorItem::addMasksToDomain(), and maskAll().
|
inherited |
Applies the detector resolution to the given intensity maps.
Definition at line 118 of file IDetector.cpp.
References IDetector::detectorMask(), IDetector::iterate(), IDetector::m_detector_resolution, SimulationAreaIterator::roiIndex(), and OutputData< T >::setRawDataVector().
Referenced by IDetector::createDetectorIntensity(), and OffSpecularSimulation::transferDetectorImage().
|
inherited |
Definition at line 56 of file IDetector.cpp.
References IDetector::dimension(), and IDetector::m_axes.
Referenced by RegionOfInterest::RegionOfInterest(), SpecularDetector1D::SpecularDetector1D(), IDetector::addAxis(), UnitConverterSimple::addDetectorAxis(), OffSpecularConverter::addDetectorYAxis(), IDetector::createDetectorMap(), RectangularDetector::createPixel(), SphericalDetector::createPixel(), getGlobalIndex(), RectangularDetector::getHeight(), RectangularDetector::getNbinsX(), RectangularDetector::getNbinsY(), RectangularDetector::getWidth(), RectangularDetector::indexOfSpecular(), SphericalDetector::indexOfSpecular(), DetectorMask::initMaskData(), OffSpecularSimulation::intensityMapSize(), DetectorUtils::isQuadratic(), RectangularDetector::regionOfInterestPixel(), SpecularDetector1D::setAxis(), TransformFromDomain::setSphericalDetector(), OffSpecularSimulation::transferDetectorImage(), and OffSpecularSimulation::transferResultsToIntensityMap().
|
inherited |
Calculate axis index for given global index.
Definition at line 63 of file IDetector.cpp.
References IDetector::dimension(), and IDetector::m_axes.
Referenced by RectangularDetector::createPixel(), and SphericalDetector::createPixel().
|
protectedpure virtualinherited |
Returns the name for the axis with given index.
Implemented in SphericalDetector, SpecularDetector1D, and RectangularDetector.
Referenced by IDetector::createAxis().
|
protectedinherited |
Definition at line 51 of file IDetector.cpp.
References IDetector::m_axes.
Referenced by SpecularDetector1D::setAxis(), and setDetectorParameters().
|
overridepure virtual |
Implements IDetector.
Implemented in SphericalDetector, RectangularDetector, and IsGISAXSDetector.
|
inherited |
Returns copyNumber of child, which takes into account existence of children with same name.
Definition at line 94 of file INode.cpp.
References INode::getChildren(), IParametricComponent::getName(), and INode::parent().
Referenced by INode::displayName().
|
protectedvirtualinherited |
Generates an axis with correct name and default binning for given index.
Reimplemented in IsGISAXSDetector.
Definition at line 78 of file IDetector.cpp.
References IDetector::axisName().
Referenced by setDetectorParameters().
std::unique_ptr< DetectorContext > IDetector2D::createContext | ( | ) | const |
Definition at line 69 of file IDetector2D.cpp.
Referenced by ISimulation2D::prepareSimulation().
|
inherited |
Returns new intensity map with detector resolution applied.
Map will be cropped to ROI if ROI is present.
Definition at line 144 of file IDetector.cpp.
References IDetector::applyDetectorResolution(), IDetector::createDetectorMap(), IDetector::m_detector_resolution, and IDetector::setDataToDetectorMap().
|
inherited |
Returns empty detector map in given axes units.
Definition at line 158 of file IDetector.cpp.
References IDetector::axis(), IDetector::dimension(), and IDetector::regionOfInterest().
Referenced by IDetector::createDetectorIntensity().
|
virtualinherited |
Creates new parameter pool, with all local parameters and those of its children.
Reimplemented from IParametricComponent.
Definition at line 126 of file INode.cpp.
References NodeUtils::nodePath(), INode::parent(), and INode::progeny().
Referenced by ISimulation::runSimulation(), DepthProbeSimulation::validateParametrization(), OffSpecularSimulation::validateParametrization(), and SpecularSimulation::validateParametrization().
|
pure virtual |
Creates an IPixel for the given OutputData object and index.
Implemented in SphericalDetector, and RectangularDetector.
Referenced by DetectorContext::setup_context().
|
inlinevirtualinherited |
Return default axes units.
Reimplemented in SphericalDetector, SpecularDetector1D, and RectangularDetector.
Definition at line 90 of file IDetector.h.
|
inlineinherited |
Returns detection properties.
Definition at line 82 of file IDetector.h.
Referenced by ISimulation2D::generateSimulationElements(), ISimulation2D::generateSingleThreadedComputation(), SpecularSimulation::generateSingleThreadedComputation(), TransformFromDomain::setDetectorProperties(), and DetectorContext::setup_context().
|
overridevirtual |
Returns detector masks container.
Implements IDetector.
Definition at line 87 of file IDetector2D.cpp.
References m_detector_mask.
|
inherited |
Returns a pointer to detector resolution object.
Definition at line 138 of file IDetector.cpp.
References IDetector::m_detector_resolution.
Referenced by TransformFromDomain::setDetectorResolution().
|
inherited |
Returns actual dimensionality of the detector (number of defined axes)
Definition at line 46 of file IDetector.cpp.
References IDetector::m_axes.
Referenced by OffSpecularConverter::OffSpecularConverter(), RectangularConverter::RectangularConverter(), SimulationArea::SimulationArea(), SphericalConverter::SphericalConverter(), IDetector::axis(), IDetector::axisBinIndex(), IDetector::createDetectorMap(), getGlobalIndex(), RectangularDetector::indexOfSpecular(), SphericalDetector::indexOfSpecular(), DetectorMask::initMaskData(), DetectorUtils::isQuadratic(), IDetector::iterate(), maskAll(), IDetector::totalSize(), OffSpecularSimulation::transferDetectorImage(), and OffSpecularSimulation::updateIntensityMap().
|
inherited |
Returns display name, composed from the name of node and it's copy number.
Definition at line 115 of file INode.cpp.
References INode::copyNumber(), IParametricComponent::getName(), and INode::m_parent.
Referenced by NodeUtils::nodePath().
|
overridevirtualinherited |
Returns a vector of children.
Reimplemented from INode.
Definition at line 192 of file IDetector.cpp.
References IDetector::m_detection_properties, and IDetector::m_detector_resolution.
|
protected |
Calculate global index from two axis indices.
Definition at line 92 of file IDetector2D.cpp.
References IDetector::axis(), IDetector::dimension(), IAxis::size(), and IDetector::totalSize().
Referenced by RectangularDetector::indexOfSpecular(), and SphericalDetector::indexOfSpecular().
|
inlineinherited |
Definition at line 70 of file IParametricComponent.h.
References IParametricComponent::m_name.
Referenced by Beam::Beam(), ConvolutionDetectorResolution::ConvolutionDetectorResolution(), IDetector::IDetector(), Instrument::Instrument(), IParametricComponent::IParametricComponent(), SampleBuilderNode::SampleBuilderNode(), Layer::clone(), INode::copyNumber(), IParametricComponent::createParameterTree(), IFormFactor::createSlicedFormFactor(), SampleToPython::defineInterferenceFunctions(), INode::displayName(), Beam::operator=(), SampleBuilderNode::operator=(), GUIObjectBuilder::populateInstrumentModel(), PyImportAssistant::populateModels(), GUIDomainSampleVisitor::populateSampleModel(), IParametricComponent::registerParameter(), IFormFactor::sliceFormFactor(), and GUIDomainSampleVisitor::visit().
|
pure virtual |
Returns index of pixel that contains the specular wavevector.
If no pixel contains this specular wavevector, the number of pixels is returned. This corresponds to an overflow index.
Implemented in SphericalDetector, RectangularDetector, and IsGISAXSDetector.
|
inlinevirtualinherited |
Inits detector with the beam settings.
Reimplemented in RectangularDetector.
Definition at line 46 of file IDetector.h.
|
inherited |
Definition at line 197 of file IDetector.cpp.
References SimulationArea::begin(), IDetector::dimension(), and SimulationArea::end().
Referenced by IDetector::applyDetectorResolution(), ISimulation::convertData(), GISASSimulation::intensityMapSize(), IDetector::numberOfSimulationElements(), and IDetector::setDataToDetectorMap().
void IDetector2D::maskAll | ( | ) |
Put the mask for all detector channels (i.e. exclude whole detector from the analysis)
Definition at line 80 of file IDetector2D.cpp.
References addMask(), and IDetector::dimension().
Referenced by ISimulation2D::maskAll().
|
inherited |
Returns number of simulation elements.
Definition at line 185 of file IDetector.cpp.
References IDetector::iterate().
|
inlinevirtualinherited |
Action to be taken in inherited class when a parameter has changed.
Reimplemented in IProfileRipple, Lattice3D, InterferenceFunction3DLattice, InterferenceFunction2DLattice, FormFactorSphereLogNormalRadius, FormFactorSphereGaussianRadius, FormFactorGaussSphere, ISawtoothRipple, ICosineRipple, IProfileRectangularRipple, FormFactorTruncatedSpheroid, FormFactorTruncatedSphere, FormFactorTruncatedCube, FormFactorTetrahedron, FormFactorPyramid, FormFactorPrism6, FormFactorPrism3, FormFactorLongBoxLorentz, FormFactorLongBoxGauss, FormFactorIcosahedron, FormFactorHollowSphere, FormFactorHemiEllipsoid, FormFactorFullSpheroid, FormFactorFullSphere, FormFactorEllipsoidalCylinder, FormFactorDodecahedron, FormFactorCylinder, FormFactorCuboctahedron, FormFactorCone6, FormFactorCone, FormFactorCantellatedCube, FormFactorBox, FormFactorAnisoPyramid, and Lattice2D.
Definition at line 59 of file IParametricComponent.h.
Referenced by Lattice2D::onChange(), and IParametricComponent::registerParameter().
|
inherited |
Returns parameter with given 'name'.
Definition at line 86 of file IParametricComponent.cpp.
References IParametricComponent::m_pool, and RealSpace::Particles::name().
Referenced by DepthProbeSimulation::initialize(), SpecularSimulation::initialize(), Lattice3D::initialize(), IParticle::registerAbundance(), ParticleLayout::registerParticleDensity(), IParticle::registerPosition(), Layer::registerThickness(), Lattice2D::setRotationEnabled(), and DistributionLogNormal::setUnits().
|
inlineinherited |
Returns pointer to the parameter pool.
Definition at line 39 of file IParametricComponent.h.
References IParametricComponent::m_pool.
Referenced by INode::INode(), IParametricComponent::IParametricComponent(), pyfmt2::argumentList(), SampleBuilderNode::borrow_builder_parameters(), SampleBuilderNode::reset(), and IDistribution1D::setUnits().
|
inherited |
Returns multiline string representing available parameters.
Definition at line 43 of file IParametricComponent.cpp.
References IParametricComponent::createParameterTree().
|
inherited |
Definition at line 89 of file INode.cpp.
References INode::m_parent.
|
inherited |
Definition at line 84 of file INode.cpp.
References INode::m_parent.
Referenced by INode::copyNumber(), INode::createParameterTree(), ParticleDistribution::generateParticles(), NodeUtils::nodePath(), Lattice2D::onChange(), SampleProvider::setBuilder(), SampleProvider::setParent(), and SampleProvider::setSample().
|
inherited |
Returns a vector of all descendants.
Definition at line 68 of file INode.cpp.
References INode::getChildren().
Referenced by INode::createParameterTree(), and ParticleDistribution::generateParticles().
|
overridevirtual |
Returns region of interest if exists.
Implements IDetector.
Definition at line 43 of file IDetector2D.cpp.
References m_region_of_interest.
Referenced by IDetector2D(), OffSpecularConverter::addDetectorYAxis(), and RectangularDetector::regionOfInterestPixel().
|
inherited |
Definition at line 57 of file INode.cpp.
References ASSERT, and INode::setParent().
Referenced by Beam::Beam(), Crystal::Crystal(), IDetector::IDetector(), Instrument::Instrument(), InterferenceFunction2DLattice::InterferenceFunction2DLattice(), InterferenceFunction2DParaCrystal::InterferenceFunction2DParaCrystal(), InterferenceFunction2DSuperLattice::InterferenceFunction2DSuperLattice(), InterferenceFunctionFinite2DLattice::InterferenceFunctionFinite2DLattice(), Particle::Particle(), ParticleDistribution::ParticleDistribution(), ParticleLayout::addAndRegisterAbstractParticle(), ParticleCoreShell::addAndRegisterCore(), MultiLayer::addAndRegisterInterface(), MultiLayer::addAndRegisterLayer(), ParticleCoreShell::addAndRegisterShell(), Layer::addLayout(), ParticleComposition::addParticlePointer(), ISimulation::initialize(), MesoCrystal::initialize(), Beam::operator=(), Instrument::operator=(), IParticle::rotate(), ParticleLayout::setAndRegisterInterferenceFunction(), ISimulation::setBackground(), InterferenceFunction1DLattice::setDecayFunction(), InterferenceFunction2DLattice::setDecayFunction(), Instrument::setDetector(), IDetector::setDetectorResolution(), Beam::setFootprintFactor(), Particle::setFormFactor(), InterferenceFunctionFinite3DLattice::setLattice(), InterferenceFunctionRadialParaCrystal::setProbabilityDistribution(), InterferenceFunction2DParaCrystal::setProbabilityDistributions(), ConvolutionDetectorResolution::setResolutionFunction(), IParticle::setRotation(), LayerInterface::setRoughness(), and InterferenceFunction2DSuperLattice::setSubstructureIFF().
|
inherited |
Definition at line 51 of file IParametricComponent.cpp.
References IParametricComponent::getName(), IParametricComponent::m_pool, RealSpace::Particles::name(), and IParametricComponent::onChange().
Referenced by BasicLattice2D::BasicLattice2D(), Beam::Beam(), CylindersInBABuilder::CylindersInBABuilder(), DetectionProperties::DetectionProperties(), HexagonalLattice2D::HexagonalLattice2D(), IInterferenceFunction::IInterferenceFunction(), INode::INode(), InterferenceFunction1DLattice::InterferenceFunction1DLattice(), InterferenceFunction2DParaCrystal::InterferenceFunction2DParaCrystal(), InterferenceFunctionHardDisk::InterferenceFunctionHardDisk(), InterferenceFunctionRadialParaCrystal::InterferenceFunctionRadialParaCrystal(), InterferenceFunctionTwin::InterferenceFunctionTwin(), Lattice2D::Lattice2D(), LayerRoughness::LayerRoughness(), MultiLayer::MultiLayer(), ParticleDistribution::ParticleDistribution(), PlainMultiLayerBySLDBuilder::PlainMultiLayerBySLDBuilder(), ResolutionFunction2DGaussian::ResolutionFunction2DGaussian(), ResonatorBuilder::ResonatorBuilder(), SquareLattice2D::SquareLattice2D(), TriangularRippleBuilder::TriangularRippleBuilder(), IParticle::registerAbundance(), ParticleLayout::registerParticleDensity(), Layer::registerThickness(), IParametricComponent::registerVector(), ParticleLayout::registerWeight(), and Lattice2D::setRotationEnabled().
|
inherited |
Definition at line 57 of file IParametricComponent.cpp.
References ModelView::Utils::base_name(), IParametricComponent::registerParameter(), RealParameter::setUnit(), IParametricComponent::XComponentName(), IParametricComponent::YComponentName(), and IParametricComponent::ZComponentName().
Referenced by Beam::Beam(), DetectionProperties::DetectionProperties(), InterferenceFunctionTwin::InterferenceFunctionTwin(), MultiLayer::MultiLayer(), Lattice3D::initialize(), and IParticle::registerPosition().
|
inherited |
Definition at line 91 of file IParametricComponent.cpp.
References IParametricComponent::m_pool, and RealSpace::Particles::name().
Referenced by IParticle::registerAbundance(), ParticleLayout::registerParticleDensity(), Layer::registerThickness(), IParametricComponent::removeVector(), and Lattice2D::setRotationEnabled().
|
inherited |
Definition at line 96 of file IParametricComponent.cpp.
References ModelView::Utils::base_name(), IParametricComponent::removeParameter(), IParametricComponent::XComponentName(), IParametricComponent::YComponentName(), and IParametricComponent::ZComponentName().
Referenced by IParticle::registerPosition().
|
overridevirtual |
Resets region of interest making whole detector plane available for the simulation.
Implements IDetector.
Definition at line 54 of file IDetector2D.cpp.
References DetectorMask::initMaskData(), m_detector_mask, and m_region_of_interest.
|
inherited |
Sets the polarization analyzer characteristics of the detector.
Definition at line 99 of file IDetector.cpp.
References IDetector::m_detection_properties, and DetectionProperties::setAnalyzerProperties().
Referenced by StandardSimulations::BasicGISAS00(), StandardSimulations::BasicPolarizedGISAS(), StandardSimulations::MaxiGISAS00(), StandardSimulations::MiniGISASPolarizationMM(), StandardSimulations::MiniGISASPolarizationMP(), StandardSimulations::MiniGISASPolarizationPM(), and StandardSimulations::MiniGISASPolarizationPP().
|
privateinherited |
Definition at line 175 of file IDetector.cpp.
References SimulationAreaIterator::elementIndex(), IDetector::iterate(), and SimulationAreaIterator::roiIndex().
Referenced by IDetector::createDetectorIntensity().
void IDetector2D::setDetectorParameters | ( | size_t | n_x, |
double | x_min, | ||
double | x_max, | ||
size_t | n_y, | ||
double | y_min, | ||
double | y_max | ||
) |
Sets detector parameters using angle ranges.
Definition at line 35 of file IDetector2D.cpp.
References IDetector::addAxis(), IDetector::clear(), and IDetector::createAxis().
Referenced by IsGISAXSDetector::IsGISAXSDetector(), RectangularDetector::RectangularDetector(), SphericalDetector::SphericalDetector(), and ISimulation2D::setDetectorParameters().
|
inherited |
Sets the detector resolution.
Definition at line 105 of file IDetector.cpp.
References IDetectorResolution::clone(), IDetector::m_detector_resolution, and INode::registerChild().
Referenced by IDetector::IDetector(), and IDetector::setResolutionFunction().
|
inlineinherited |
Definition at line 69 of file IParametricComponent.h.
References IParametricComponent::m_name, and RealSpace::Particles::name().
Referenced by BasicLattice2D::BasicLattice2D(), Beam::Beam(), ConvolutionDetectorResolution::ConvolutionDetectorResolution(), Crystal::Crystal(), DetectionProperties::DetectionProperties(), DistributionHandler::DistributionHandler(), FormFactorCoreShell::FormFactorCoreShell(), FormFactorCrystal::FormFactorCrystal(), FormFactorDecoratorMaterial::FormFactorDecoratorMaterial(), FormFactorDecoratorPositionFactor::FormFactorDecoratorPositionFactor(), FormFactorDecoratorRotation::FormFactorDecoratorRotation(), FormFactorWeighted::FormFactorWeighted(), HexagonalLattice2D::HexagonalLattice2D(), IDetector::IDetector(), INode::INode(), Instrument::Instrument(), InterferenceFunction1DLattice::InterferenceFunction1DLattice(), InterferenceFunction2DLattice::InterferenceFunction2DLattice(), InterferenceFunction2DParaCrystal::InterferenceFunction2DParaCrystal(), InterferenceFunction2DSuperLattice::InterferenceFunction2DSuperLattice(), InterferenceFunction3DLattice::InterferenceFunction3DLattice(), InterferenceFunctionFinite2DLattice::InterferenceFunctionFinite2DLattice(), InterferenceFunctionFinite3DLattice::InterferenceFunctionFinite3DLattice(), InterferenceFunctionHardDisk::InterferenceFunctionHardDisk(), InterferenceFunctionNone::InterferenceFunctionNone(), InterferenceFunctionRadialParaCrystal::InterferenceFunctionRadialParaCrystal(), InterferenceFunctionTwin::InterferenceFunctionTwin(), ISampleBuilder::ISampleBuilder(), IsGISAXSDetector::IsGISAXSDetector(), Lattice3D::Lattice3D(), Layer::Layer(), LayerInterface::LayerInterface(), LayerRoughness::LayerRoughness(), MultiLayer::MultiLayer(), ParticleCoreShell::ParticleCoreShell(), ParticleDistribution::ParticleDistribution(), ParticleLayout::ParticleLayout(), RectangularDetector::RectangularDetector(), ResolutionFunction2DGaussian::ResolutionFunction2DGaussian(), SampleBuilderNode::SampleBuilderNode(), SphericalDetector::SphericalDetector(), SquareLattice2D::SquareLattice2D(), Layer::clone(), LayersWithAbsorptionBuilder::createSampleByIndex(), Basic2DParaCrystalBuilder::createSampleByIndex(), ParticleInVacuumBuilder::createSampleByIndex(), SimpleMagneticRotationBuilder::createSampleByIndex(), DepthProbeSimulation::initialize(), GISASSimulation::initialize(), OffSpecularSimulation::initialize(), SpecularSimulation::initialize(), SpecularDetector1D::initialize(), MesoCrystal::initialize(), Particle::initialize(), ParticleComposition::initialize(), Beam::operator=(), SampleBuilderNode::operator=(), SampleBuilderNode::reset(), and SampleBuilderNode::setSBN().
|
inherited |
Definition at line 65 of file IParametricComponent.cpp.
References IParametricComponent::createParameterTree(), IParametricComponent::m_pool, RealSpace::Particles::name(), and ParameterPool::setMatchedParametersValue().
Referenced by AsymRippleBuilder::buildSample(), and IParametricComponent::setVectorValue().
|
virtualinherited |
Reimplemented in SampleProvider.
Definition at line 79 of file INode.cpp.
References INode::m_parent.
Referenced by INode::registerChild(), SampleProvider::setBuilder(), and SampleProvider::setParent().
void IDetector2D::setRegionOfInterest | ( | double | xlow, |
double | ylow, | ||
double | xup, | ||
double | yup | ||
) |
Sets rectangular region of interest with lower left and upper right corners defined.
Definition at line 48 of file IDetector2D.cpp.
References DetectorMask::initMaskData(), m_detector_mask, and m_region_of_interest.
Referenced by DetectorItem::addMasksToDomain(), and ISimulation2D::setRegionOfInterest().
|
inherited |
Definition at line 112 of file IDetector.cpp.
References IDetector::setDetectorResolution().
Referenced by ISimulation::setDetectorResolutionFunction().
|
inherited |
Definition at line 78 of file IParametricComponent.cpp.
References ModelView::Utils::base_name(), IParametricComponent::setParameterValue(), BasicVector3D< T >::x(), IParametricComponent::XComponentName(), BasicVector3D< T >::y(), IParametricComponent::YComponentName(), BasicVector3D< T >::z(), and IParametricComponent::ZComponentName().
|
inherited |
Returns total number of pixels.
Definition at line 88 of file IDetector.cpp.
References IDetector::dimension(), and IDetector::m_axes.
Referenced by SimulationArea::SimulationArea(), getGlobalIndex(), IsGISAXSDetector::indexOfSpecular(), RectangularDetector::indexOfSpecular(), and SphericalDetector::indexOfSpecular().
|
inlinevirtualinherited |
Used for Python overriding of clone (see swig/tweaks.py)
Definition at line 34 of file ICloneable.h.
|
virtualinherited |
Returns multiline string representing tree structure below the node.
Definition at line 52 of file INode.cpp.
References NodeUtils::nodeToString().
|
staticinherited |
Definition at line 103 of file IParametricComponent.cpp.
References ModelView::Utils::base_name().
Referenced by Lattice3D::initialize(), IParticle::registerPosition(), IParametricComponent::registerVector(), IParametricComponent::removeVector(), IParametricComponent::setVectorValue(), and VectorParameterTranslator::translate().
|
staticinherited |
Definition at line 108 of file IParametricComponent.cpp.
References ModelView::Utils::base_name().
Referenced by IParametricComponent::registerVector(), IParametricComponent::removeVector(), IParametricComponent::setVectorValue(), and VectorParameterTranslator::translate().
|
staticinherited |
Definition at line 113 of file IParametricComponent.cpp.
References ModelView::Utils::base_name().
Referenced by IParametricComponent::registerVector(), IParametricComponent::removeVector(), IParametricComponent::setVectorValue(), and VectorParameterTranslator::translate().
|
privateinherited |
Definition at line 114 of file IDetector.h.
Referenced by IDetector::addAxis(), IDetector::axis(), IDetector::axisBinIndex(), IDetector::clear(), IDetector::dimension(), and IDetector::totalSize().
|
privateinherited |
Definition at line 115 of file IDetector.h.
Referenced by IDetector::IDetector(), IDetector::getChildren(), and IDetector::setAnalyzerProperties().
|
private |
Definition at line 86 of file IDetector2D.h.
Referenced by addMask(), detectorMask(), resetRegionOfInterest(), and setRegionOfInterest().
|
privateinherited |
Definition at line 116 of file IDetector.h.
Referenced by IDetector::IDetector(), IDetector::applyDetectorResolution(), IDetector::createDetectorIntensity(), IDetector::detectorResolution(), IDetector::getChildren(), and IDetector::setDetectorResolution().
|
privateinherited |
Definition at line 73 of file IParametricComponent.h.
Referenced by IParametricComponent::getName(), and IParametricComponent::setName().
|
protectedinherited |
Definition at line 88 of file INode.h.
Referenced by INode::INode().
|
protectedinherited |
Definition at line 89 of file INode.h.
Referenced by INode::INode(), and IFootprintFactor::setWidthRatio().
|
privateinherited |
Definition at line 83 of file INode.h.
Referenced by INode::displayName(), INode::parent(), and INode::setParent().
|
privateinherited |
parameter pool (kind of pointer-to-implementation)
Definition at line 74 of file IParametricComponent.h.
Referenced by IParametricComponent::createParameterTree(), IParametricComponent::parameter(), IParametricComponent::parameterPool(), IParametricComponent::registerParameter(), IParametricComponent::removeParameter(), and IParametricComponent::setParameterValue().
|
private |
Definition at line 87 of file IDetector2D.h.
Referenced by IDetector2D(), regionOfInterest(), resetRegionOfInterest(), and setRegionOfInterest().