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 | |
IDetector () | |
IDetector * | clone () const override=0 |
virtual | ~IDetector () |
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 |
virtual const DetectorMask * | detectorMask () const =0 |
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 |
virtual const RegionOfInterest * | regionOfInterest () const =0 |
virtual void | resetRegionOfInterest ()=0 |
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 | |
IDetector (const IDetector &other) | |
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 | |
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 detector interface.
Definition at line 35 of file IDetector.h.
using IDetector::const_iterator = const SimulationAreaIterator& |
Definition at line 38 of file IDetector.h.
IDetector::IDetector | ( | ) |
Definition at line 22 of file IDetector.cpp.
References m_detection_properties, and INode::registerChild().
|
virtualdefault |
|
protected |
Definition at line 27 of file IDetector.cpp.
References IParameterized::getName(), m_detection_properties, mP_detector_resolution, INode::registerChild(), setDetectorResolution(), and IParameterized::setName().
|
overridepure virtual |
Implements ICloneable.
Implemented in IDetector2D, SphericalDetector, SpecularDetector1D, RectangularDetector, and IsGISAXSDetector.
Referenced by Instrument::setDetector().
|
inlinevirtual |
Inits detector with the beam settings.
Reimplemented in RectangularDetector.
Definition at line 46 of file IDetector.h.
void IDetector::addAxis | ( | const IAxis & | axis | ) |
Definition at line 39 of file IDetector.cpp.
References IAxis::clone(), m_axes, and CloneableVector< T >::push_back().
Referenced by IDetector2D::setDetectorParameters(), and SpecularDetector1D::SpecularDetector1D().
const IAxis & IDetector::getAxis | ( | size_t | index | ) | const |
Definition at line 54 of file IDetector.cpp.
References dimension(), and m_axes.
Referenced by UnitConverterSimple::addDetectorAxis(), OffSpecularConverter::addDetectorYAxis(), createDetectorMap(), RectangularDetector::createPixel(), SphericalDetector::createPixel(), anonymous_namespace{Simulation.cpp}::detHasSameDimensions(), IDetector2D::getGlobalIndex(), RectangularDetector::getHeight(), RectangularDetector::getNbinsX(), RectangularDetector::getNbinsY(), RectangularDetector::getWidth(), RectangularDetector::indexOfSpecular(), SphericalDetector::indexOfSpecular(), DetectorMask::initMaskData(), RegionOfInterest::RegionOfInterest(), and RectangularDetector::regionOfInterestPixel().
size_t IDetector::dimension | ( | ) | const |
Returns actual dimensionality of the detector (number of defined axes)
Definition at line 44 of file IDetector.cpp.
References m_axes.
Referenced by axisBinIndex(), createDetectorMap(), SimulationToPython::defineDetector(), anonymous_namespace{Simulation.cpp}::detHasSameDimensions(), getAxis(), IDetector2D::getGlobalIndex(), RectangularDetector::indexOfSpecular(), SphericalDetector::indexOfSpecular(), DetectorMask::initMaskData(), iterate(), IDetector2D::maskAll(), OffSpecularConverter::OffSpecularConverter(), RectangularConverter::RectangularConverter(), SimulationArea::SimulationArea(), SphericalConverter::SphericalConverter(), and totalSize().
size_t IDetector::axisBinIndex | ( | size_t | index, |
size_t | selected_axis | ||
) | const |
Calculate axis index for given global index.
Definition at line 61 of file IDetector.cpp.
References dimension(), and m_axes.
Referenced by RectangularDetector::createPixel(), and SphericalDetector::createPixel().
size_t IDetector::totalSize | ( | ) | const |
Returns total number of pixels.
Definition at line 87 of file IDetector.cpp.
References dimension(), and m_axes.
Referenced by IDetector2D::getGlobalIndex(), IsGISAXSDetector::indexOfSpecular(), RectangularDetector::indexOfSpecular(), SphericalDetector::indexOfSpecular(), and SimulationArea::SimulationArea().
|
pure virtual |
Returns detector masks container.
Implemented in SpecularDetector1D, and IDetector2D.
Referenced by applyDetectorResolution(), SimulationToPython::defineMasks(), and SimulationArea::isMasked().
void IDetector::setAnalyzerProperties | ( | const kvector_t | direction, |
double | efficiency, | ||
double | total_transmission | ||
) |
Sets the polarization analyzer characteristics of the detector.
Definition at line 98 of file IDetector.cpp.
References m_detection_properties, and DetectionProperties::setAnalyzerProperties().
void IDetector::setDetectorResolution | ( | const IDetectorResolution & | p_detector_resolution | ) |
Sets the detector resolution.
Definition at line 104 of file IDetector.cpp.
References IDetectorResolution::clone(), mP_detector_resolution, and INode::registerChild().
Referenced by IDetector(), and setResolutionFunction().
void IDetector::setResolutionFunction | ( | const IResolutionFunction2D & | resFunc | ) |
Definition at line 111 of file IDetector.cpp.
References setDetectorResolution().
void IDetector::applyDetectorResolution | ( | OutputData< double > * | p_intensity_map | ) | const |
Applies the detector resolution to the given intensity maps.
Definition at line 117 of file IDetector.cpp.
References detectorMask(), iterate(), mP_detector_resolution, SimulationAreaIterator::roiIndex(), and OutputData< T >::setRawDataVector().
Referenced by createDetectorIntensity().
void IDetector::removeDetectorResolution | ( | ) |
Removes detector resolution function.
Definition at line 137 of file IDetector.cpp.
References mP_detector_resolution.
const IDetectorResolution * IDetector::detectorResolution | ( | ) | const |
Returns a pointer to detector resolution object.
Definition at line 142 of file IDetector.cpp.
References mP_detector_resolution.
Referenced by SimulationToPython::defineDetectorResolutionFunction().
std::unique_ptr< OutputData< double > > IDetector::createDetectorMap | ( | ) | const |
Returns empty detector map in given axes units.
Definition at line 162 of file IDetector.cpp.
References dimension(), getAxis(), and regionOfInterest().
Referenced by createDetectorIntensity().
|
pure virtual |
Returns region of interest if exists.
Implemented in SpecularDetector1D, and IDetector2D.
Referenced by UnitConverterSimple::addDetectorAxis(), createDetectorMap(), SimulationToPython::defineDetector(), SimulationArea::detectorIndex(), and SimulationArea::SimulationArea().
|
pure virtual |
Resets region of interest making whole detector plane available for the simulation.
Implemented in SpecularDetector1D, and IDetector2D.
|
inline |
Returns detection properties.
Definition at line 93 of file IDetector.h.
References m_detection_properties.
Referenced by SimulationToPython::defineDetectorPolarizationAnalysis(), Simulation2D::generateSimulationElements(), anonymous_namespace{SpecularSimulation.cpp}::generateSimulationElements(), and DetectorContext::setup_context().
OutputData< double > * IDetector::createDetectorIntensity | ( | const std::vector< SimulationElement > & | elements | ) | const |
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 applyDetectorResolution(), createDetectorMap(), mP_detector_resolution, and setDataToDetectorMap().
|
inlinevirtual |
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().
size_t IDetector::numberOfSimulationElements | ( | ) | const |
Returns number of simulation elements.
Definition at line 189 of file IDetector.cpp.
References iterate().
|
overridevirtual |
Returns a vector of children (const).
Reimplemented from INode.
Definition at line 196 of file IDetector.cpp.
References m_detection_properties, and mP_detector_resolution.
void IDetector::iterate | ( | std::function< void(const_iterator)> | func, |
bool | visit_masks = false |
||
) | const |
Definition at line 201 of file IDetector.cpp.
References SimulationArea::begin(), dimension(), and SimulationArea::end().
Referenced by applyDetectorResolution(), Simulation::convertData(), GISASSimulation::intensityMapSize(), numberOfSimulationElements(), and setDataToDetectorMap().
|
protected |
Definition at line 49 of file IDetector.cpp.
References m_axes.
Referenced by IDetector2D::setDetectorParameters().
|
protectedpure virtual |
Returns the name for the axis with given index.
Implemented in SphericalDetector, SpecularDetector1D, and RectangularDetector.
Referenced by createAxis().
|
protectedvirtual |
Generates an axis with correct name and default binning for given index.
Reimplemented in IsGISAXSDetector.
Definition at line 76 of file IDetector.cpp.
References axisName().
Referenced by IDetector2D::setDetectorParameters().
|
private |
Definition at line 179 of file IDetector.cpp.
References SimulationAreaIterator::elementIndex(), iterate(), and SimulationAreaIterator::roiIndex().
Referenced by 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(), 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(), 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(), 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(), Instrument::Instrument(), IParameterized::IParameterized(), Beam::operator=(), SampleBuilderNode::operator=(), anonymous_namespace{ParticleLayout.cpp}::particleDensityIsProvidedByInterference(), IParameterized::registerParameter(), SampleBuilderNode::SampleBuilderNode(), and IFormFactor::sliceFormFactor().
|
private |
Definition at line 126 of file IDetector.h.
Referenced by addAxis(), axisBinIndex(), clear(), dimension(), getAxis(), and totalSize().
|
private |
Definition at line 127 of file IDetector.h.
Referenced by detectionProperties(), getChildren(), IDetector(), and setAnalyzerProperties().
|
private |
Definition at line 128 of file IDetector.h.
Referenced by applyDetectorResolution(), createDetectorIntensity(), detectorResolution(), getChildren(), IDetector(), removeDetectorResolution(), and 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().