BornAgain
1.18.0
Simulate and fit neutron and x-ray scattering at grazing incidence
|
Public Types | |
using | const_iterator = const SimulationAreaIterator & |
Public Member Functions | |
IDetector2D () | |
IDetector2D * | clone () const override=0 |
virtual | ~IDetector2D () |
void | setDetectorParameters (size_t n_x, double x_min, double x_max, size_t n_y, double y_min, double y_max) |
void | removeMasks () |
const DetectorMask * | detectorMask () const override |
void | addMask (const IShape2D &shape, bool mask_value=true) |
void | maskAll () |
const RegionOfInterest * | regionOfInterest () const override |
void | setRegionOfInterest (double xlow, double ylow, double xup, double yup) |
void | resetRegionOfInterest () override |
std::vector< size_t > | active_indices () const |
virtual IPixel * | createPixel (size_t index) const =0 |
virtual size_t | indexOfSpecular (const Beam &beam) const =0 |
std::unique_ptr< DetectorContext > | createContext () const |
virtual void | init (const Beam &) |
void | addAxis (const IAxis &axis) |
const IAxis & | getAxis (size_t index) const |
size_t | dimension () const |
size_t | axisBinIndex (size_t index, size_t selected_axis) const |
size_t | totalSize () const |
void | setAnalyzerProperties (const kvector_t direction, double efficiency, double total_transmission) |
void | setDetectorResolution (const IDetectorResolution &p_detector_resolution) |
void | setResolutionFunction (const IResolutionFunction2D &resFunc) |
void | applyDetectorResolution (OutputData< double > *p_intensity_map) const |
void | removeDetectorResolution () |
const IDetectorResolution * | detectorResolution () const |
std::unique_ptr< OutputData< double > > | createDetectorMap () const |
const DetectionProperties & | detectionProperties () const |
OutputData< double > * | createDetectorIntensity (const std::vector< SimulationElement > &elements) const |
virtual Axes::Units | defaultAxesUnits () const |
size_t | numberOfSimulationElements () const |
std::vector< const INode * > | getChildren () const override |
void | iterate (std::function< void(const_iterator)> func, bool visit_masks=false) const |
virtual void | transferToCPP () |
virtual void | accept (INodeVisitor *visitor) const =0 |
virtual std::string | treeToString () const |
void | registerChild (INode *node) |
virtual void | setParent (const INode *newParent) |
const INode * | parent () const |
INode * | parent () |
int | copyNumber (const INode *node) const |
std::string | displayName () const |
ParameterPool * | createParameterTree () const |
ParameterPool * | parameterPool () const |
std::string | parametersToString () const |
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 | setParameterValue (const std::string &name, double value) |
void | setVectorValue (const std::string &base_name, kvector_t value) |
RealParameter * | parameter (const std::string &name) const |
virtual void | onChange () |
void | removeParameter (const std::string &name) |
void | removeVector (const std::string &base_name) |
void | setName (const std::string &name) |
const std::string & | getName () const |
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) | |
size_t | getGlobalIndex (size_t x, size_t y) const |
void | clear () |
virtual std::string | axisName (size_t index) const =0 |
virtual std::unique_ptr< IAxis > | createAxis (size_t index, size_t n_bins, double min, double max) const |
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 | |
DetectorMask | m_detector_mask |
std::unique_ptr< RegionOfInterest > | m_region_of_interest |
CloneableVector< IAxis > | m_axes |
DetectionProperties | m_detection_properties |
std::unique_ptr< IDetectorResolution > | mP_detector_resolution |
const INode * | m_parent {nullptr} |
std::string | m_name |
std::unique_ptr< ParameterPool > | m_pool |
Abstract 2D detector interface.
Definition at line 30 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().
|
overridepure virtual |
Implements IDetector.
Implemented in SphericalDetector, RectangularDetector, and IsGISAXSDetector.
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(), StandardSimulations::IsGISAXSSimulation1(), StandardSimulations::IsGISAXSSimulation2(), RectangularDetector::RectangularDetector(), Simulation2D::setDetectorParameters(), and SphericalDetector::SphericalDetector().
void IDetector2D::removeMasks | ( | ) |
Removes all masks from the detector.
Definition at line 74 of file IDetector2D.cpp.
References m_detector_mask, and DetectorMask::removeMasks().
Referenced by Simulation2D::removeMasks().
|
overridevirtual |
Returns detector masks container.
Implements IDetector.
Definition at line 93 of file IDetector2D.cpp.
References m_detector_mask.
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 79 of file IDetector2D.cpp.
References DetectorMask::addMask(), DetectorMask::initMaskData(), and m_detector_mask.
Referenced by Simulation2D::addMask(), and maskAll().
void IDetector2D::maskAll | ( | ) |
Put the mask for all detector channels (i.e. exclude whole detector from the analysis)
Definition at line 85 of file IDetector2D.cpp.
References addMask(), IDetector::dimension(), m_detector_mask, and DetectorMask::removeMasks().
Referenced by Simulation2D::maskAll().
|
overridevirtual |
Returns region of interest if exists.
Implements IDetector.
Definition at line 43 of file IDetector2D.cpp.
References m_region_of_interest.
Referenced by OffSpecularConverter::addDetectorYAxis(), IDetector2D(), and RectangularDetector::regionOfInterestPixel().
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 Simulation2D::setRegionOfInterest().
|
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.
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().
|
pure virtual |
Creates an IPixel for the given OutputData object and index.
Implemented in SphericalDetector, and RectangularDetector.
Referenced by DetectorContext::setup_context().
|
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.
Referenced by Simulation2D::generateSimulationElements().
std::unique_ptr< DetectorContext > IDetector2D::createContext | ( | ) | const |
Definition at line 69 of file IDetector2D.cpp.
Referenced by Simulation2D::prepareSimulation().
|
protected |
Calculate global index from two axis indices.
Definition at line 98 of file IDetector2D.cpp.
References IDetector::dimension(), IDetector::getAxis(), IAxis::size(), and IDetector::totalSize().
Referenced by RectangularDetector::indexOfSpecular(), and SphericalDetector::indexOfSpecular().
|
inlinevirtualinherited |
Inits detector with the beam settings.
Reimplemented in RectangularDetector.
Definition at line 46 of file IDetector.h.
|
inherited |
Definition at line 39 of file IDetector.cpp.
References IAxis::clone(), IDetector::m_axes, and CloneableVector< T >::push_back().
Referenced by setDetectorParameters(), and SpecularDetector1D::SpecularDetector1D().
|
inherited |
Definition at line 54 of file IDetector.cpp.
References IDetector::dimension(), and IDetector::m_axes.
Referenced by UnitConverterSimple::addDetectorAxis(), OffSpecularConverter::addDetectorYAxis(), IDetector::createDetectorMap(), RectangularDetector::createPixel(), SphericalDetector::createPixel(), anonymous_namespace{Simulation.cpp}::detHasSameDimensions(), getGlobalIndex(), RectangularDetector::getHeight(), RectangularDetector::getNbinsX(), RectangularDetector::getNbinsY(), RectangularDetector::getWidth(), RectangularDetector::indexOfSpecular(), SphericalDetector::indexOfSpecular(), DetectorMask::initMaskData(), RegionOfInterest::RegionOfInterest(), and RectangularDetector::regionOfInterestPixel().
|
inherited |
Returns actual dimensionality of the detector (number of defined axes)
Definition at line 44 of file IDetector.cpp.
References IDetector::m_axes.
Referenced by IDetector::axisBinIndex(), IDetector::createDetectorMap(), SimulationToPython::defineDetector(), anonymous_namespace{Simulation.cpp}::detHasSameDimensions(), IDetector::getAxis(), getGlobalIndex(), RectangularDetector::indexOfSpecular(), SphericalDetector::indexOfSpecular(), DetectorMask::initMaskData(), IDetector::iterate(), maskAll(), OffSpecularConverter::OffSpecularConverter(), RectangularConverter::RectangularConverter(), SimulationArea::SimulationArea(), SphericalConverter::SphericalConverter(), and IDetector::totalSize().
|
inherited |
Calculate axis index for given global index.
Definition at line 61 of file IDetector.cpp.
References IDetector::dimension(), and IDetector::m_axes.
Referenced by RectangularDetector::createPixel(), and SphericalDetector::createPixel().
|
inherited |
Returns total number of pixels.
Definition at line 87 of file IDetector.cpp.
References IDetector::dimension(), and IDetector::m_axes.
Referenced by getGlobalIndex(), IsGISAXSDetector::indexOfSpecular(), RectangularDetector::indexOfSpecular(), SphericalDetector::indexOfSpecular(), and SimulationArea::SimulationArea().
|
inherited |
Sets the polarization analyzer characteristics of the detector.
Definition at line 98 of file IDetector.cpp.
References IDetector::m_detection_properties, and DetectionProperties::setAnalyzerProperties().
|
inherited |
Sets the detector resolution.
Definition at line 104 of file IDetector.cpp.
References IDetectorResolution::clone(), IDetector::mP_detector_resolution, and INode::registerChild().
Referenced by IDetector::IDetector(), and IDetector::setResolutionFunction().
|
inherited |
Definition at line 111 of file IDetector.cpp.
References IDetector::setDetectorResolution().
|
inherited |
Applies the detector resolution to the given intensity maps.
Definition at line 117 of file IDetector.cpp.
References IDetector::detectorMask(), IDetector::iterate(), IDetector::mP_detector_resolution, SimulationAreaIterator::roiIndex(), and OutputData< T >::setRawDataVector().
Referenced by IDetector::createDetectorIntensity().
|
inherited |
Removes detector resolution function.
Definition at line 137 of file IDetector.cpp.
References IDetector::mP_detector_resolution.
|
inherited |
Returns a pointer to detector resolution object.
Definition at line 142 of file IDetector.cpp.
References IDetector::mP_detector_resolution.
Referenced by SimulationToPython::defineDetectorResolutionFunction().
|
inherited |
Returns empty detector map in given axes units.
Definition at line 162 of file IDetector.cpp.
References IDetector::dimension(), IDetector::getAxis(), and IDetector::regionOfInterest().
Referenced by IDetector::createDetectorIntensity().
|
inlineinherited |
Returns detection properties.
Definition at line 93 of file IDetector.h.
References IDetector::m_detection_properties.
Referenced by SimulationToPython::defineDetectorPolarizationAnalysis(), Simulation2D::generateSimulationElements(), anonymous_namespace{SpecularSimulation.cpp}::generateSimulationElements(), and DetectorContext::setup_context().
|
inherited |
Returns new intensity map with detector resolution applied.
Map will be cropped to ROI if ROI is present.
Definition at line 148 of file IDetector.cpp.
References IDetector::applyDetectorResolution(), IDetector::createDetectorMap(), IDetector::mP_detector_resolution, and IDetector::setDataToDetectorMap().
|
inlinevirtualinherited |
Return default axes units.
Reimplemented in SphericalDetector, SpecularDetector1D, and RectangularDetector.
Definition at line 101 of file IDetector.h.
Referenced by anonymous_namespace{SimulationToPython.cpp}::printFunc().
|
inherited |
Returns number of simulation elements.
Definition at line 189 of file IDetector.cpp.
References IDetector::iterate().
|
overridevirtualinherited |
Returns a vector of children (const).
Reimplemented from INode.
Definition at line 196 of file IDetector.cpp.
References IDetector::m_detection_properties, and IDetector::mP_detector_resolution.
|
inherited |
Definition at line 201 of file IDetector.cpp.
References SimulationArea::begin(), IDetector::dimension(), and SimulationArea::end().
Referenced by IDetector::applyDetectorResolution(), Simulation::convertData(), GISASSimulation::intensityMapSize(), IDetector::numberOfSimulationElements(), and IDetector::setDataToDetectorMap().
|
protectedinherited |
Definition at line 49 of file IDetector.cpp.
References IDetector::m_axes.
Referenced by setDetectorParameters().
|
protectedpure virtualinherited |
Returns the name for the axis with given index.
Implemented in SphericalDetector, SpecularDetector1D, and RectangularDetector.
Referenced by IDetector::createAxis().
|
protectedvirtualinherited |
Generates an axis with correct name and default binning for given index.
Reimplemented in IsGISAXSDetector.
Definition at line 76 of file IDetector.cpp.
References IDetector::axisName().
Referenced by setDetectorParameters().
|
privateinherited |
Definition at line 179 of file IDetector.cpp.
References SimulationAreaIterator::elementIndex(), IDetector::iterate(), and SimulationAreaIterator::roiIndex().
Referenced by IDetector::createDetectorIntensity().
|
inlinevirtualinherited |
Used for Python overriding of clone (see swig/tweaks.py)
Definition at line 34 of file ICloneable.h.
|
pure virtualinherited |
Calls the INodeVisitor's visit method.
Implemented in FormFactorSphereLogNormalRadius, FormFactorSphereGaussianRadius, FormFactorGaussSphere, FormFactorDecoratorRotation, FormFactorDecoratorPositionFactor, FormFactorDecoratorMaterial, ParticleDistribution, ParticleCoreShell, ParticleComposition, Particle, MesoCrystal, FormFactorWeighted, FormFactorCrystal, FormFactorCoreShell, Crystal, Layer, 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, FormFactorAnisoPyramid, FTDistribution1DVoigt, FTDistribution1DCosine, FTDistribution1DTriangle, FTDistribution1DGate, FTDistribution1DGauss, FTDistribution1DCauchy, InterferenceFunctionTwin, InterferenceFunctionRadialParaCrystal, InterferenceFunctionNone, InterferenceFunctionHardDisk, InterferenceFunctionFinite3DLattice, InterferenceFunctionFinite2DLattice, InterferenceFunction3DLattice, InterferenceFunction2DSuperLattice, InterferenceFunction2DParaCrystal, InterferenceFunction2DLattice, InterferenceFunction1DLattice, SpecularSimulation, DepthProbeSimulation, FormFactorDWBAPol, FormFactorDWBA, FormFactorBAPol, Lattice, MisesGaussPeakShape, MisesFisherGaussPeakShape, LorentzFisherPeakShape, GaussFisherPeakShape, IsotropicLorentzPeakShape, IsotropicGaussPeakShape, SphericalDetector, SpecularDetector1D, FootprintSquare, FootprintGauss, Beam, GISASSimulation, PoissonNoiseBackground, ConstantBackground, MultiLayer, ParticleLayout, SampleProvider, SampleBuilderNode, HexagonalLattice, SquareLattice, BasicLattice, FormFactorBarLorentz, FormFactorBarGauss, FTDistribution2DVoigt, FTDistribution2DCone, FTDistribution2DGate, FTDistribution2DGauss, FTDistribution2DCauchy, FTDecayFunction2DVoigt, FTDecayFunction2DGauss, FTDecayFunction2DCauchy, FTDecayFunction1DVoigt, FTDecayFunction1DTriangle, FTDecayFunction1DGauss, FTDecayFunction1DCauchy, DistributionTrapezoid, DistributionCosine, DistributionLogNormal, DistributionGaussian, DistributionLorentz, DistributionGate, ResolutionFunction2DGaussian, ConvolutionDetectorResolution, Instrument, RectangularDetector, IsGISAXSDetector, DetectionProperties, OffSpecSimulation, ILayout, LayerRoughness, LayerInterface, RotationEuler, RotationZ, RotationY, RotationX, IdentityRotation, and IAbstractParticle.
Referenced by VisitNodesPostorder(), and VisitNodesPreorder().
|
virtualinherited |
Returns multiline string representing tree structure below the node.
Definition at line 53 of file INode.cpp.
References NodeUtils::nodeToString().
|
inherited |
Definition at line 58 of file INode.cpp.
References ASSERT, and INode::setParent().
Referenced by ParticleLayout::addAndRegisterAbstractParticle(), ParticleCoreShell::addAndRegisterCore(), MultiLayer::addAndRegisterInterface(), MultiLayer::addAndRegisterLayer(), ParticleCoreShell::addAndRegisterShell(), Layer::addLayout(), ParticleComposition::addParticlePointer(), Beam::Beam(), Crystal::Crystal(), IDetector::IDetector(), Simulation::initialize(), MesoCrystal::initialize(), Instrument::Instrument(), Beam::operator=(), Instrument::operator=(), Particle::Particle(), ParticleDistribution::ParticleDistribution(), IParticle::rotate(), ParticleLayout::setAndRegisterInterferenceFunction(), Simulation::setBackground(), InterferenceFunction1DLattice::setDecayFunction(), InterferenceFunction2DLattice::setDecayFunction(), Instrument::setDetector(), IDetector::setDetectorResolution(), Beam::setFootprintFactor(), Particle::setFormFactor(), InterferenceFunctionFinite3DLattice::setLattice(), InterferenceFunction2DLattice::setLattice(), InterferenceFunction2DParaCrystal::setLattice(), InterferenceFunction2DSuperLattice::setLattice(), InterferenceFunctionFinite2DLattice::setLattice(), InterferenceFunctionRadialParaCrystal::setProbabilityDistribution(), InterferenceFunction2DParaCrystal::setProbabilityDistributions(), ConvolutionDetectorResolution::setResolutionFunction(), IParticle::setRotation(), LayerInterface::setRoughness(), and InterferenceFunction2DSuperLattice::setSubstructureIFF().
|
virtualinherited |
Reimplemented in SampleProvider.
Definition at line 69 of file INode.cpp.
References INode::m_parent.
Referenced by INode::registerChild(), SampleProvider::setBuilder(), and SampleProvider::setParent().
|
inherited |
Definition at line 74 of file INode.cpp.
References INode::m_parent.
Referenced by INode::copyNumber(), INode::createParameterTree(), NodeUtils::nodePath(), Lattice2D::onChange(), SampleProvider::setBuilder(), SampleProvider::setParent(), and SampleProvider::setSample().
|
inherited |
|
inherited |
Returns copyNumber of child, which takes into account existence of children with same name.
Definition at line 84 of file INode.cpp.
References INode::getChildren(), IParameterized::getName(), and INode::parent().
Referenced by INode::displayName().
|
inherited |
Returns display name, composed from the name of node and it's copy number.
Definition at line 105 of file INode.cpp.
References INode::copyNumber(), IParameterized::getName(), and INode::m_parent.
Referenced by NodeUtils::nodePath(), and anonymous_namespace{NodeUtils.cpp}::nodeString().
|
virtualinherited |
Creates new parameter pool, with all local parameters and those of its children.
Reimplemented from IParameterized.
Definition at line 116 of file INode.cpp.
References ParameterPool::copyToExternalPool(), NodeIterator< Strategy >::first(), NodeIterator< Strategy >::getCurrent(), NodeIterator< Strategy >::isDone(), NodeIterator< Strategy >::next(), NodeUtils::nodePath(), IParameterized::parameterPool(), and INode::parent().
Referenced by ParticleDistribution::generateParticles(), Simulation::runSimulation(), DepthProbeSimulation::validateParametrization(), OffSpecSimulation::validateParametrization(), and SpecularSimulation::validateParametrization().
|
inlineinherited |
Returns pointer to the parameter pool.
Definition at line 38 of file IParameterized.h.
References IParameterized::m_pool.
Referenced by pyfmt2::argumentList(), SampleBuilderNode::borrow_builder_parameters(), INode::createParameterTree(), INode::INode(), IParameterized::IParameterized(), anonymous_namespace{NodeUtils.cpp}::poolToString(), SampleBuilderNode::reset(), and IDistribution1D::setUnits().
|
inherited |
Returns multiline string representing available parameters.
Definition at line 40 of file IParameterized.cpp.
References IParameterized::createParameterTree().
|
inherited |
Definition at line 48 of file IParameterized.cpp.
References IParameterized::getName(), IParameterized::m_pool, and IParameterized::onChange().
Referenced by BasicLattice::BasicLattice(), Beam::Beam(), CylindersInBABuilder::CylindersInBABuilder(), DetectionProperties::DetectionProperties(), HexagonalLattice::HexagonalLattice(), IInterferenceFunction::IInterferenceFunction(), INode::INode(), InterferenceFunction1DLattice::InterferenceFunction1DLattice(), InterferenceFunction2DParaCrystal::InterferenceFunction2DParaCrystal(), InterferenceFunctionHardDisk::InterferenceFunctionHardDisk(), InterferenceFunctionRadialParaCrystal::InterferenceFunctionRadialParaCrystal(), InterferenceFunctionTwin::InterferenceFunctionTwin(), Lattice2D::Lattice2D(), LayerRoughness::LayerRoughness(), MultiLayer::MultiLayer(), ParticleDistribution::ParticleDistribution(), PlainMultiLayerBySLDBuilder::PlainMultiLayerBySLDBuilder(), IParticle::registerAbundance(), ParticleLayout::registerParticleDensity(), Layer::registerThickness(), IParameterized::registerVector(), ParticleLayout::registerWeight(), ResolutionFunction2DGaussian::ResolutionFunction2DGaussian(), ResonatorBuilder::ResonatorBuilder(), Lattice2D::setRotationEnabled(), SquareLattice::SquareLattice(), and TriangularRippleBuilder::TriangularRippleBuilder().
|
inherited |
Definition at line 54 of file IParameterized.cpp.
References IParameterized::registerParameter(), RealParameter::setUnit(), IParameterized::XComponentName(), IParameterized::YComponentName(), and IParameterized::ZComponentName().
Referenced by Beam::Beam(), DetectionProperties::DetectionProperties(), InterferenceFunctionTwin::InterferenceFunctionTwin(), MultiLayer::MultiLayer(), Lattice::registerBasisVectors(), and IParticle::registerPosition().
|
inherited |
Definition at line 62 of file IParameterized.cpp.
References IParameterized::createParameterTree(), IParameterized::m_pool, and ParameterPool::setMatchedParametersValue().
Referenced by AsymRippleBuilder::buildSample(), and IParameterized::setVectorValue().
|
inherited |
Definition at line 75 of file IParameterized.cpp.
References IParameterized::setParameterValue(), BasicVector3D< T >::x(), IParameterized::XComponentName(), BasicVector3D< T >::y(), IParameterized::YComponentName(), BasicVector3D< T >::z(), and IParameterized::ZComponentName().
|
inherited |
Returns parameter with given 'name'.
Definition at line 83 of file IParameterized.cpp.
References IParameterized::m_pool.
Referenced by DepthProbeSimulation::initialize(), SpecularSimulation::initialize(), IParticle::registerAbundance(), Lattice::registerBasisVectors(), ParticleLayout::registerParticleDensity(), IParticle::registerPosition(), Layer::registerThickness(), Lattice2D::setRotationEnabled(), and DistributionLogNormal::setUnits().
|
inlinevirtualinherited |
Action to be taken in inherited class when a parameter has changed.
Reimplemented in IProfileRipple, 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, InterferenceFunction3DLattice, InterferenceFunction2DLattice, Lattice, and Lattice2D.
Definition at line 58 of file IParameterized.h.
Referenced by Lattice2D::onChange(), and IParameterized::registerParameter().
|
inherited |
Definition at line 88 of file IParameterized.cpp.
References IParameterized::m_pool.
Referenced by IParticle::registerAbundance(), ParticleLayout::registerParticleDensity(), Layer::registerThickness(), IParameterized::removeVector(), and Lattice2D::setRotationEnabled().
|
inherited |
Definition at line 93 of file IParameterized.cpp.
References IParameterized::removeParameter(), IParameterized::XComponentName(), IParameterized::YComponentName(), and IParameterized::ZComponentName().
Referenced by IParticle::registerPosition().
|
staticinherited |
Definition at line 100 of file IParameterized.cpp.
Referenced by Lattice::registerBasisVectors(), IParticle::registerPosition(), IParameterized::registerVector(), IParameterized::removeVector(), and IParameterized::setVectorValue().
|
staticinherited |
Definition at line 105 of file IParameterized.cpp.
Referenced by IParameterized::registerVector(), IParameterized::removeVector(), and IParameterized::setVectorValue().
|
staticinherited |
Definition at line 110 of file IParameterized.cpp.
Referenced by IParameterized::registerVector(), IParameterized::removeVector(), and IParameterized::setVectorValue().
|
inlineinherited |
Definition at line 68 of file IParameterized.h.
References IParameterized::m_name.
Referenced by BasicLattice::BasicLattice(), Beam::Beam(), Layer::clone(), ConvolutionDetectorResolution::ConvolutionDetectorResolution(), LayersWithAbsorptionBuilder::createSampleByIndex(), Basic2DParaCrystalBuilder::createSampleByIndex(), ParticleInVacuumBuilder::createSampleByIndex(), SimpleMagneticRotationBuilder::createSampleByIndex(), Crystal::Crystal(), DetectionProperties::DetectionProperties(), DistributionHandler::DistributionHandler(), FormFactorBAPol::FormFactorBAPol(), FormFactorCoreShell::FormFactorCoreShell(), FormFactorCrystal::FormFactorCrystal(), FormFactorDecoratorMaterial::FormFactorDecoratorMaterial(), FormFactorDecoratorPositionFactor::FormFactorDecoratorPositionFactor(), FormFactorDecoratorRotation::FormFactorDecoratorRotation(), FormFactorDWBA::FormFactorDWBA(), FormFactorDWBAPol::FormFactorDWBAPol(), FormFactorWeighted::FormFactorWeighted(), HexagonalLattice::HexagonalLattice(), IDetector::IDetector(), DepthProbeSimulation::initialize(), GISASSimulation::initialize(), OffSpecSimulation::initialize(), SpecularSimulation::initialize(), SpecularDetector1D::initialize(), MesoCrystal::initialize(), Particle::initialize(), ParticleComposition::initialize(), 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(), Lattice::Lattice(), Layer::Layer(), LayerInterface::LayerInterface(), LayerRoughness::LayerRoughness(), MultiLayer::MultiLayer(), Beam::operator=(), SampleBuilderNode::operator=(), ParticleCoreShell::ParticleCoreShell(), ParticleDistribution::ParticleDistribution(), ParticleLayout::ParticleLayout(), RectangularDetector::RectangularDetector(), SampleBuilderNode::reset(), ResolutionFunction2DGaussian::ResolutionFunction2DGaussian(), SampleBuilderNode::SampleBuilderNode(), SampleBuilderNode::setSBN(), SphericalDetector::SphericalDetector(), and SquareLattice::SquareLattice().
|
inlineinherited |
Definition at line 69 of file IParameterized.h.
References IParameterized::m_name.
Referenced by Beam::Beam(), Layer::clone(), IFormFactorBorn::computeSlicingEffects(), ConvolutionDetectorResolution::ConvolutionDetectorResolution(), INode::copyNumber(), IParameterized::createParameterTree(), IFormFactor::createSlicedFormFactor(), SampleToPython::defineFormFactors(), SampleToPython::defineInterferenceFunctions(), INode::displayName(), IDetector::IDetector(), Instrument::Instrument(), IParameterized::IParameterized(), Beam::operator=(), SampleBuilderNode::operator=(), anonymous_namespace{ParticleLayout.cpp}::particleDensityIsProvidedByInterference(), IParameterized::registerParameter(), SampleBuilderNode::SampleBuilderNode(), and IFormFactor::sliceFormFactor().
|
private |
Definition at line 89 of file IDetector2D.h.
Referenced by addMask(), detectorMask(), maskAll(), removeMasks(), resetRegionOfInterest(), and setRegionOfInterest().
|
private |
Definition at line 90 of file IDetector2D.h.
Referenced by IDetector2D(), regionOfInterest(), resetRegionOfInterest(), and setRegionOfInterest().
|
privateinherited |
Definition at line 126 of file IDetector.h.
Referenced by IDetector::addAxis(), IDetector::axisBinIndex(), IDetector::clear(), IDetector::dimension(), IDetector::getAxis(), and IDetector::totalSize().
|
privateinherited |
Definition at line 127 of file IDetector.h.
Referenced by IDetector::detectionProperties(), IDetector::getChildren(), IDetector::IDetector(), and IDetector::setAnalyzerProperties().
|
privateinherited |
Definition at line 128 of file IDetector.h.
Referenced by IDetector::applyDetectorResolution(), IDetector::createDetectorIntensity(), IDetector::detectorResolution(), IDetector::getChildren(), IDetector::IDetector(), IDetector::removeDetectorResolution(), and IDetector::setDetectorResolution().
|
privateinherited |
Definition at line 81 of file INode.h.
Referenced by INode::displayName(), INode::parent(), and INode::setParent().
|
protectedinherited |
Definition at line 86 of file INode.h.
Referenced by INode::INode().
|
protectedinherited |
Definition at line 87 of file INode.h.
Referenced by INode::INode(), and IFootprintFactor::setWidthRatio().
|
privateinherited |
Definition at line 72 of file IParameterized.h.
Referenced by IParameterized::getName(), and IParameterized::setName().
|
privateinherited |
parameter pool (kind of pointer-to-implementation)
Definition at line 73 of file IParameterized.h.
Referenced by IParameterized::createParameterTree(), IParameterized::parameter(), IParameterized::parameterPool(), IParameterized::registerParameter(), IParameterized::removeParameter(), and IParameterized::setParameterValue().