▼ Base | |
► Axis | |
Bin.cpp | Implements structs Bin1D, Bin1DCVector |
Bin.h | Defines structs Bin1D, Bin1DCVector |
ConstKBinAxis.cpp | Implement class ConstKBinAxis |
ConstKBinAxis.h | Defines class ConstKBinAxis |
CustomBinAxis.cpp | Implement class CustomBinAxis |
CustomBinAxis.h | Defines class CustomBinAxis |
FixedBinAxis.cpp | Implement class FixedBinAxis |
FixedBinAxis.h | Defines class FixedBinAxis |
IAxis.cpp | Implements class IAxis |
IAxis.h | Defines class IAxis |
PointwiseAxis.cpp | Implements class PointwiseAxis |
PointwiseAxis.h | Defines class PointwiseAxis |
VariableBinAxis.cpp | Implements VariableBinAxis class |
VariableBinAxis.h | Defines class VariableBinAxis |
► Const | |
MathConstants.h | Defines M_PI and some more mathematical constants |
PhysicalConstants.h | Defines the values of physical constants (SI) |
Units.h | Defines some unit conversion factors and other constants in namespace Units |
► Pixel | |
IPixel.h | Defines pure virtual interface IPixel (has no cpp file) |
PolarizationHandler.cpp | Implements class PolarizationHandler |
PolarizationHandler.h | Defines class PolarizationHandler |
SimulationElement.cpp | Implements class SimulationElement |
SimulationElement.h | Defines class SimulationElement |
► Types | |
CloneableVector.h | Defines and implements templated class CloneableVector |
Complex.h | Defines complex_t, and a few elementary functions |
Exceptions.cpp | Implements class Exceptions |
Exceptions.h | Defines many exception classes in namespace Exceptionss |
ICloneable.h | Defines and implements the standard mix-in ICloneable |
SafePointerVector.h | Defines and implements template class SafePointerVector |
► Utils | |
Algorithms.h | Defines and implements namespace algo with some algorithms |
Assert.h | Defines the macro ASSERT |
FileSystemUtils.cpp | Implements namespace FileSystemUtils |
FileSystemUtils.h | Defines namespace FileSystemUtils |
Integrator.cpp | Implements classes RealIntegrator, ComplexIntegrator |
Integrator.h | Defines classes RealIntegrator, ComplexIntegrator |
IntegratorMCMiser.h | Defines and implements template class IntegratorMCMiser |
MathFunctions.cpp | Implements namespace MathFunctions |
MathFunctions.h | Defines namespace MathFunctions |
Precomputed.h | Defines namespace Precomputed, providing precomputed constants |
PyEmbeddedUtils.cpp | IOmplements various functions from PyEmbeddedUtils namespace |
PyEmbeddedUtils.h | Defines PyEmbeddedUtils namespace |
PyFmt.cpp | Implements functions from namespace pyfmt |
PyFmt.h | Defines functions in namespace pyfmt |
PyObject.h | PyObvject forward declaration |
PythonCore.h | Includes python header and takes care of warnings |
SysUtils.cpp | Implements various stuff in namespace Utils |
SysUtils.h | Defines various stuff in namespace Utils |
ThreadInfo.h | Defines struct ThreadInfo |
► Vector | |
BasicVector3D.cpp | Implements type-specific functions from template class BasicVector3D |
BasicVector3D.h | Declares and partly implements template class BasicVector3D |
EigenCore.h | Include to deal with Eigen alignment centrally |
Transform3D.cpp | Implements template class Transform3D |
Transform3D.h | Declares class Transform3D |
Vectors3D.h | Defines basic vectors in R^3 and C^3 |
▼ Core | |
► Computation | |
ComputationStatus.h | Defines and implements interface class ComputationStatus |
ConstantBackground.cpp | Implements class ConstantBackground |
ConstantBackground.h | Defines class ConstantBackground |
DelayedProgressCounter.cpp | Implements class DelayedProgressCounter |
DelayedProgressCounter.h | Defines class DelayedProgressCounter |
DepthProbeComputation.cpp | Implements class DepthProbeComputation |
DepthProbeComputation.h | Declares class DepthProbeComputation |
DepthProbeComputationTerm.cpp | Implements functor DepthProbeComputationTerm |
DepthProbeComputationTerm.h | Defines functor DepthProbeComputationTerm |
DepthProbeElement.cpp | Implements class DepthProbeElement |
DepthProbeElement.h | Defines class DepthProbeElement |
DWBAComputation.cpp | Implements class DWBAComputation |
DWBAComputation.h | Defines class DWBAComputation |
DWBASingleComputation.cpp | Implements class DWBASingleComputation |
DWBASingleComputation.h | Defines class DWBASingleComputation |
GISASSpecularComputation.cpp | Implements class GISASSpecularComputation |
GISASSpecularComputation.h | Defines class GISASSpecularComputation |
IBackground.cpp | Implements interface IBackground |
IBackground.h | Defines interface IBackground |
IComputation.cpp | Implements interface IComputation |
IComputation.h | Defines interface IComputation |
LayoutStrategyBuilder.cpp | Implements class LayoutStrategyBuilder |
LayoutStrategyBuilder.h | Defines class LayoutStrategyBuilder |
MultiLayerFuncs.cpp | Global functions related to MultiLayers |
MultiLayerFuncs.h | Global functions related to MultiLayers |
ParticleLayoutComputation.cpp | Implements class ParticleLayoutComputation |
ParticleLayoutComputation.h | Defines class ParticleLayoutComputation |
PoissonNoiseBackground.cpp | Implements class PoissonNoiseBackground |
PoissonNoiseBackground.h | Defines class PoissonNoiseBackground |
ProcessedLayout.cpp | Implements class ProcessedLayout |
ProcessedLayout.h | Defines class ProcessedLayout |
ProcessedSample.cpp | Implements class ProcessedSample |
ProcessedSample.h | Defines class ProcessedSample |
ProfileHelper.cpp | Implements class ProfileHelper |
ProfileHelper.h | Defines class ProfileHelper |
ProgressHandler.cpp | Implements class ProgressHandler |
ProgressHandler.h | Defines class ProgressHandler |
RoughMultiLayerComputation.cpp | Implements class RoughMultiLayerComputation |
RoughMultiLayerComputation.h | Defines class RoughMultiLayerComputation |
SpecularComputation.cpp | Implements class SpecularComputation |
SpecularComputation.h | Defines class SpecularComputation |
SpecularComputationTerm.cpp | Implements functor SpecularComputationTerm |
SpecularComputationTerm.h | Defines classes SpecularComputationTerm, SpecularScalarTerm, SpecularMatrixTerm |
SpecularStrategyBuilder.cpp | Implements class SpecularStrategyBuilder |
SpecularStrategyBuilder.h | Defines class SpecularStrategyBuilder |
► Export | |
ExportToPython.cpp | Implements ExportToPython namespace |
ExportToPython.h | Defines ExportToPython namespace |
INodeUtils.h | Defines namespace INodeUtils |
OrderedMap.h | Defines class OrderedMap |
SampleLabelHandler.cpp | Implement class SampleLabelHandler |
SampleLabelHandler.h | Defines classes LabelMap and SampleLabelHandler |
SampleToPython.cpp | Implements class SampleToPython |
SampleToPython.h | Defines class SampleToPython |
SimulationToPython.cpp | Implements class SimulationToPython |
SimulationToPython.h | Defines class SimulationToPython |
► Fitting | |
FitObjective.cpp | Implements class FitObjective |
FitObjective.h | Defines class FitObjective |
FitObserver.h | Defines class FitObserver |
FitPrintService.cpp | Defines class FitPrintService |
FitPrintService.h | Defines class FitPrintService |
FitStatus.cpp | Implements class FitStatus |
FitStatus.h | Defines class FitStatus |
FitTypes.h | Defines common types for fitting library |
IObserver.cpp | Implements class IObserver, mostly by including IObserver.h |
IObserver.h | Defines classes IObserver and IObservable (Observer pattern) |
IterationInfo.cpp | Implements class IterationInfo |
IterationInfo.h | Defines class IterationInfo |
ObjectiveMetric.cpp | Implements ObjectiveMetric classes |
ObjectiveMetric.h | Defines ObjectiveMetric classes |
ObjectiveMetricUtils.cpp | Implements ObjectiveMetric utilities |
ObjectiveMetricUtils.h | Defines ObjectiveMetric utilities and corresponding namespace |
PyFittingCallbacks.cpp | Implements family of PyFittingCallbacks classes |
PyFittingCallbacks.h | Defines family of PyFittingCallbacks classes |
SimDataPair.cpp | Defines class SimDataPair |
SimDataPair.h | Defines class SimDataPair |
► Scan | |
AngularSpecScan.cpp | Implements AngularSpecScan class |
AngularSpecScan.h | Declares AngularSpecScan class |
ISpecularScan.h | Declares and implements pure virtual class ISpecularScan |
QSpecScan.cpp | Implements QSpecScan class |
QSpecScan.h | Declares QSpecScan class |
UnitConverter1D.cpp | Implements UnitConverter1D class and derived classes |
UnitConverter1D.h | Defines UnitConverter1D class and derived classes |
► Simulation | |
DepthProbeSimulation.cpp | Implements class DepthProbeSimulation |
DepthProbeSimulation.h | Defines class DepthProbeSimulation |
GISASSimulation.cpp | Implements class Simulation |
GISASSimulation.h | Defines class GISASSimulation |
MPISimulation.cpp | Implements class MPISimulation |
MPISimulation.h | Defines class MPISimulation |
OffSpecSimulation.cpp | Implements class OffSpecSimulation |
OffSpecSimulation.h | Defines class OffSpecSimulation |
Simulation.cpp | Implements class Simulation |
Simulation.h | Defines class Simulation |
Simulation2D.cpp | Implements class Simulation2D |
Simulation2D.h | Defines class Simulation2D |
SimulationFactory.cpp | Implement class SimulationFactory |
SimulationFactory.h | Defines class SimulationFactory |
SpecularSimulation.cpp | Implements class OffSpecSimulation |
SpecularSimulation.h | Defines class SpecularSimulation |
StandardSimulations.cpp | Implements functions for standard simulations |
StandardSimulations.h | Defines namespace and functions for standard simulations |
UnitConverterUtils.cpp | Implements utilities for unit convertion |
UnitConverterUtils.h | Declares utilities for unit converters |
▼ Device | |
► Beam | |
Beam.cpp | Implements class Beam |
Beam.h | Defines class Beam |
FootprintGauss.cpp | Implements class FootprintGauss |
FootprintGauss.h | Defines class FootprintGauss |
FootprintSquare.cpp | Implements class FootprintSquare |
FootprintSquare.h | Defines class FootprintSquare |
IFootprintFactor.cpp | Implements class IFootprintFactor |
IFootprintFactor.h | Defines class IFootprintFactor |
► Data | |
CumulativeValue.cpp | Implements class CumulativeValue |
CumulativeValue.h | Defines class CumulativeValue |
LLData.cpp | Implements template specializations for LLData |
LLData.h | Defines class LLData |
OutputData.cpp | Implements template specializations of class OutputData.cpp |
OutputData.h | Defines and implements template class OutputData |
OutputDataIterator.h | Defines and implements template class OutputDataIterator |
► Detector | |
DetectionProperties.cpp | Implements class DetectionProperties |
DetectionProperties.h | Defines class DetectionProperties |
DetectorContext.cpp | Implements DetectorContext class |
DetectorContext.h | Define DetectorContext class |
DetectorMask.cpp | Implements class DetectorMask |
DetectorMask.h | Defines class DetectorMask |
IDetector.cpp | Implements common detector interface |
IDetector.h | Defines common detector interface |
IDetector2D.cpp | Implements shared functionality of interface IDetector2D |
IDetector2D.h | Defines interface IDetector2D |
IsGISAXSDetector.cpp | Implements class IsGISAXSDetector |
IsGISAXSDetector.h | Defines class IsGISAXSDetector |
RectangularDetector.cpp | Implements class RectangularDetector |
RectangularDetector.h | Defines class RectangularDetector |
RectangularPixel.cpp | Implements class RectangularPixel |
RectangularPixel.h | Defines class RectangularPixel |
RegionOfInterest.cpp | Implements class RegionOfInterest |
RegionOfInterest.h | Defines class RegionOfInterest |
SimpleUnitConverters.cpp | Implements IUnitConverter classes |
SimpleUnitConverters.h | Defines interface UnitConverterSimple and its subclasses |
SimulationArea.cpp | Implements class SimulationArea |
SimulationArea.h | Defines class SimulationArea |
SimulationAreaIterator.cpp | Implements class SimulationAreaIterator |
SimulationAreaIterator.h | Defines class SimulationAreaIterator |
SpecularDetector1D.cpp | Implements a detector for specular simulations |
SpecularDetector1D.h | Defines a detector for specular simulations |
SphericalDetector.cpp | Implements class SphericalDetector |
SphericalDetector.h | Defines class SphericalDetector |
SphericalPixel.cpp | Implements class SphericalPixel |
SphericalPixel.h | Defines class SphericalPixel |
► Histo | |
Histogram1D.cpp | Implements class Histogram1D |
Histogram1D.h | Defines class Histogram1D |
Histogram2D.cpp | Implements class Histogram2D |
Histogram2D.h | Defines class Histogram2D |
IHistogram.cpp | Implements class IntensityDataObject |
IHistogram.h | Defines class IHistogram |
IntensityDataIOFactory.cpp | Implements class OutputDataIOFactory |
IntensityDataIOFactory.h | Defines class IntensityDataIOFactory |
SimulationResult.cpp | Implements class SimulationResult |
SimulationResult.h | Defines class SimulationResult |
► InputOutput | |
boost_streams.h | Contains boost streams related headers |
DataFormatUtils.cpp | Implements class DataFormatUtils |
DataFormatUtils.h | Defines class OutputDataIOFactory |
OutputDataReader.cpp | Implements class OutputDataReader |
OutputDataReader.h | Defines class OutputDataReader |
OutputDataReadFactory.cpp | Implements class OutputDataReadFactory |
OutputDataReadFactory.h | Defines class OutputDataReadFactory |
OutputDataReadStrategy.cpp | Implements class OutputDataReadStrategy |
OutputDataReadStrategy.h | Defines IOutputDataReadStrategy and related classes |
OutputDataWriteFactory.cpp | Implements class OutputDataWriteFactory |
OutputDataWriteFactory.h | Defines class OutputDataWriteFactory |
OutputDataWriter.cpp | Implements class OutputDataWriter |
OutputDataWriter.h | Defines class OutputDataWriter |
OutputDataWriteStrategy.cpp | Implements class OutputDataWriteStrategy |
OutputDataWriteStrategy.h | Defines classes IOutputDataWriteStrategy and OutputDataWriteStreamIMA |
TiffHandler.cpp | Implements class TiffReadStrategy |
TiffHandler.h | Defines class TiffHandler |
► Instrument | |
ChiSquaredModule.cpp | Implements class ChiSquaredModule |
ChiSquaredModule.h | Defines class ChiSquaredModule |
FourierTransform.cpp | Implements class FourierTransform |
FourierTransform.h | Defines class MathFunctions::FourierTransform |
IChiSquaredModule.cpp | Implements class IChiSquaredModule |
IChiSquaredModule.h | Defines class IChiSquaredModule |
Instrument.cpp | Implements class Instrument |
Instrument.h | Defines class Instrument |
IntensityDataFunctions.cpp | Implement class IntensityDataFunctions |
IntensityDataFunctions.h | Defines class IntensityDataFunctions |
PyArrayImportUtils.cpp | Implements functions in namespace PyArrayImport |
PyArrayImportUtils.h | Declares functions in namespace PyArrayImport |
PyFmt2.cpp | Implements functions from namespace pyfmt2 |
PyFmt2.h | Defines namespace pyfmt2 |
SpectrumUtils.cpp | PyObvject forward declaration |
SpectrumUtils.h | PyObvject forward declaration |
VarianceFunctions.cpp | Implements IVarianceFunction classes |
VarianceFunctions.h | Defines IVarianceFunction classes |
► Intensity | |
ArrayUtils.cpp | Implements various functions to interact from numpy on Python side |
ArrayUtils.h | Defines various functions to interact from numpy on Python side |
IIntensityFunction.cpp | Implements the classes IntensityFunctionLog, IntensityFunctionSqrt |
IIntensityFunction.h | Defines and implements the interface class IIntensityFunction and its child classes IntensityFunctionLog, IntensityFunctionSqrt |
► Mask | |
Ellipse.cpp | Implements class Ellipse |
Ellipse.h | Defines class Rectangle |
InfinitePlane.h | Defines class InfinitePlane |
IShape2D.h | Defines basic class for all 2D shapes |
Line.cpp | Implements class Line |
Line.h | Defines class Line |
Polygon.cpp | Implements class Polygon |
Polygon.h | Defines class Polygon |
Rectangle.cpp | Implements class Rectangle |
Rectangle.h | Defines class Rectangle |
► Resolution | |
ConvolutionDetectorResolution.cpp | Implements class ConvolutionDetectorResolution |
ConvolutionDetectorResolution.h | Defines class ConvolutionDetectorResolution |
Convolve.cpp | Implements class Convolve |
Convolve.h | Defines class MathFunctions::Convolve |
IDetectorResolution.h | Defines class IDetectorResolution |
IResolutionFunction2D.cpp | Defines interface class IResolutionFunction2D |
IResolutionFunction2D.h | Defines interface class IResolutionFunction2D |
ResolutionFunction2DGaussian.cpp | Implements class ResolutionFunction2DGaussian |
ResolutionFunction2DGaussian.h | Defines class ResolutionFunction2DGaussian |
ScanResolution.cpp | Implements scan resolution class and derived ones |
ScanResolution.h | Defines scan resolution class |
► Unit | |
AxisNames.cpp | Implements functions in namespace AxisNames |
AxisNames.h | Defines namespace AxisNames |
IUnitConverter.cpp | Implements IUnitConverter class |
IUnitConverter.h | Defines interface IUnitConverter and possible axis units |
▼ Doc | |
Doxygen | |
▼ Fit | |
► Kernel | |
FitOptions.cpp | Implements class FitOptions |
FitOptions.h | Defines class FitOptions |
IFunctionAdapter.cpp | Implements class IFunctionAdapter |
IFunctionAdapter.h | Defines class IFunctionAdapter |
Kernel.cpp | Implements class Kernel |
Kernel.h | Defines class Kernel |
KernelTypes.h | Defines common types for fitting library |
Minimizer.cpp | Implements class Minimizer |
Minimizer.h | Defines class Minimizer |
MinimizerResult.cpp | Implements class MinimizerResult |
MinimizerResult.h | Defines class MinimizerResult |
Parameter.cpp | Implements class Parameter |
Parameter.h | Defines class Parameter |
Parameters.cpp | Defines class Parameters |
Parameters.h | Defines class Parameters |
PyCallback.cpp | Implements class PyCallback |
PyCallback.h | Defines class PyCallback |
► Minimizer | |
IMinimizer.cpp | Implements class IMinimizer |
IMinimizer.h | Defines class IMinimizer |
MinimizerCatalog.cpp | Implements class MinimizerCatalog |
MinimizerCatalog.h | Defines class MinimizerCatalog |
MinimizerFactory.cpp | Implements class MinimizerFactory |
MinimizerFactory.h | Defines class MinimizerFactory |
MinimizerInfo.cpp | Implements class MinimizerInfo |
MinimizerInfo.h | Declares class MinimizerInfo |
MinimizerOptions.cpp | Implements class MinimizerOptions |
MinimizerOptions.h | Declares class MinimizerOptions |
TestMinimizer.cpp | Implements class TrivialMinimizer |
TestMinimizer.h | Defines class TestMinimizer |
► RootAdapter | |
GeneticMinimizer.cpp | Implements class GeneticMinimizer |
GeneticMinimizer.h | Declares class GeneticMinimizer |
GSLLevenbergMarquardtMinimizer.cpp | Implements class GSLLevenbergMarquardtMinimizer |
GSLLevenbergMarquardtMinimizer.h | Declares class GSLLevenbergMarquardtMinimizer |
GSLMultiMinimizer.cpp | Implements class GSLMultiMinimizer |
GSLMultiMinimizer.h | Declares class GSLMultiMinimizer |
MinimizerResultUtils.cpp | Implements MinimizerResultUtils namespace |
MinimizerResultUtils.h | Declares MinimizerResultUtils namespace |
Minuit2Minimizer.cpp | Declares class Minuit2Minimizer |
Minuit2Minimizer.h | Declares class Minuit2Minimizer |
ObjectiveFunctionAdapter.cpp | Implements class ObjectiveFunctionAdapter |
ObjectiveFunctionAdapter.h | Declares class ObjectiveFunctionAdapter |
ResidualFunctionAdapter.cpp | Implements class ResidualFunctionAdapter |
ResidualFunctionAdapter.h | Defines class ResidualFunctionAdapter |
RootMinimizerAdapter.cpp | Implements class RootMinimizerAdapter |
RootMinimizerAdapter.h | Declares class RootMinimizerAdapter |
RootResidualFunction.cpp | Implements class RootResidualFunction |
RootResidualFunction.h | Declares class RootResidualFunction |
RootScalarFunction.cpp | Implements class RootScalarFunction |
RootScalarFunction.h | Defines classes RootScalarFunction |
ScalarFunctionAdapter.cpp | Defines class ScalarFunctionAdapter |
ScalarFunctionAdapter.h | Defines class ScalarFunctionAdapter |
SimAnMinimizer.cpp | Implements class SimAnMinimizer |
SimAnMinimizer.h | Declares class SimAnMinimizer |
► TestEngine | |
IFactory.h | Defines interface class IFactory |
MinimizerTestPlan.cpp | Implements class MinimizerTestPlan |
MinimizerTestPlan.h | Defines class MinimizerTestPlan |
Numeric.cpp | Implements "almost equal" in namespace Numeric |
Numeric.h | Defines constants and "almost equal" in namespace Numeric |
ParameterPlan.h | Defines class ParameterPlan |
► Tools | |
AttLimits.cpp | Implements and implements class AttLimits |
AttLimits.h | Defines and implements class AttLimits |
Attributes.h | Defines and implements class Attributes |
MinimizerUtils.cpp | Declares namespace MinimizerUtils |
MinimizerUtils.h | Declares namespace MinimizerUtils |
MultiOption.cpp | Implements class MultiOption |
MultiOption.h | Declares class MultiOption |
OptionContainer.cpp | Implements class OptionContainer |
OptionContainer.h | Declares class OptionContainer |
RealLimits.cpp | Implements class Limits |
RealLimits.h | Defines class RealLimits |
StringUtils.cpp | Implements a few helper functions |
StringUtils.h | Defines a few helper functions |
WallclockTimer.cpp | Implements class WallclockTimer |
WallclockTimer.h | Defines WallclockTimer class |
▼ Param | |
► Base | |
IParameter.h | Defines and implements pure virtual base class IParameter<T> |
IParameterized.cpp | Implements class IParameterized |
IParameterized.h | Defines class IParameterized |
ParameterPool.cpp | Implements standard mix-in ParameterPool |
ParameterPool.h | Defines class ParameterPool |
RealParameter.cpp | Implements class RealParameter |
RealParameter.h | Defines class RealParameter |
Unit.h | Defines class Unit |
► Distrib | |
DistributionHandler.cpp | Implements class DistributionHandler |
DistributionHandler.h | Defines class DistributionHandler |
Distributions.cpp | Implements classes representing one-dimensional distributions |
Distributions.h | Defines classes representing one-dimensional distributions |
ParameterDistribution.cpp | Implements class ParameterDistribution |
ParameterDistribution.h | Defines class ParameterDistribution |
RangedDistributions.cpp | Implements classes representing ranged one-dimensional distributions |
RangedDistributions.h | Defines classes representing ranged one-dimensional distributions |
► Node | |
INode.cpp | Implements class INode |
INode.h | Defines class INode |
INodeVisitor.cpp | Implements class INodeVisitor |
INodeVisitor.h | Defines interface class INodeVisitor |
IterationStrategy.cpp | Implements class IterationStrategy and children |
IterationStrategy.h | Defines class IterationStrategy and children |
NodeIterator.cpp | Implements class IteratorState |
NodeIterator.h | Defines classes IteratorState, IteratorMemento and NodeIterator |
NodeUtils.cpp | Implements collection of utility functions for INode |
NodeUtils.h | Defines collection of utility functions for INode |
► Varia | |
ParameterPattern.cpp | Implements class ParameterPattern |
ParameterPattern.h | Defines class ParameterPattern |
ParameterSample.h | Defines class ParameterSample |
ParameterUtils.cpp | Implements namespace ParameterUtils |
ParameterUtils.h | Defines namespace ParameterUtils |
PyFmtLimits.cpp | Implements functions from namespace pyfmt |
PyFmtLimits.h | Defines functions in namespace pyfmt |
▼ Sample | |
► Aggregate | |
IInterferenceFunction.cpp | Implements the interface class IInterferenceFunction |
IInterferenceFunction.h | Defines and implements the interface class IInterferenceFunction |
InterferenceFunction1DLattice.cpp | Implements class InterferenceFunction1DLattice |
InterferenceFunction1DLattice.h | Defines class InterferenceFunction1DLattice |
InterferenceFunction2DLattice.cpp | Implements class InterferenceFunction2DLattice |
InterferenceFunction2DLattice.h | Defines class InterferenceFunction2DLattice |
InterferenceFunction2DParaCrystal.cpp | Implements class InterferenceFunction2DParaCrystal |
InterferenceFunction2DParaCrystal.h | Defines class InterferenceFunction2DParaCrystal |
InterferenceFunction2DSuperLattice.cpp | Implements class InterferenceFunction2DSuperLattice |
InterferenceFunction2DSuperLattice.h | Defines class InterferenceFunction2DSuperLattice |
InterferenceFunction3DLattice.cpp | Implements class InterferenceFunction3DLattice |
InterferenceFunction3DLattice.h | Defines class InterferenceFunction3DLattice |
InterferenceFunctionFinite2DLattice.cpp | Implements class InterferenceFunctionFinite2DLattice |
InterferenceFunctionFinite2DLattice.h | Defines class InterferenceFunctionFinite2DLattice |
InterferenceFunctionFinite3DLattice.cpp | Implements class InterferenceFunctionFinite2DLattice |
InterferenceFunctionFinite3DLattice.h | Defines class InterferenceFunctionFinite3DLattice |
InterferenceFunctionHardDisk.cpp | Implements class InterferenceFunctionHardDisk |
InterferenceFunctionHardDisk.h | Defines class InterferenceFunctionHardDisk |
InterferenceFunctionNone.cpp | Implements class InterferenceFunctionNone |
InterferenceFunctionNone.h | Defines class InterferenceFunctionNone |
InterferenceFunctionRadialParaCrystal.cpp | Implements class InterferenceFunctionRadialParaCrystal |
InterferenceFunctionRadialParaCrystal.h | Defines class InterferenceFunctionRadialParaCrystal |
InterferenceFunctions.h | Includes all interference function definitions |
InterferenceFunctionTwin.cpp | Implements class InterferenceFunctionTwin |
InterferenceFunctionTwin.h | Defines class InterferenceFunctionTwin |
ParticleLayout.cpp | Implements class ParticleLayout |
ParticleLayout.h | Defines class ParticleLayout |
► Correlations | |
FTDecay1D.cpp | Implements class FTDistribution2DCauchy |
FTDecay1D.h | Defines classes IFTDecayFunction1D, IFTDecayFunction2D, |
FTDecay2D.cpp | Implements class FTDistribution2DCauchy |
FTDecay2D.h | Defines classes IFTDecayFunction1D, IFTDecayFunction2D, |
FTDistributions1D.cpp | Implements interface class IFTDistribution2D and children thereof |
FTDistributions1D.h | Defines interface class IFTDistribution1D, and children thereof |
FTDistributions2D.cpp | Implements interface class IFTDistribution2D and children thereof |
FTDistributions2D.h | Defines interface class IFTDistribution2D, and children thereof |
IDistribution1DSampler.cpp | Defines interface class IFTDistribution1D, and children thereof |
IDistribution1DSampler.h | Defines interface class IFTDistribution1D, and children thereof |
IDistribution2DSampler.cpp | Defines interface class IFTDistribution1D, and children thereof |
IDistribution2DSampler.h | Defines interface class IFTDistribution1D, and children thereof |
ILayout.cpp | Implements interface class ILayout |
ILayout.h | Defines and implements interface class ILayout |
IPeakShape.cpp | Implements the interface IPeakShape and subclasses |
IPeakShape.h | Defines the interface IPeakShape and subclasses |
► Fresnel | |
FormFactorCoherentPart.cpp | Implements class FormFactorCoherentPart |
FormFactorCoherentPart.h | Defines class FormFactorCoherentPart |
FormFactorCoherentSum.cpp | Implements class FormFactorCoherentSum |
FormFactorCoherentSum.h | Defines class FormFactorCoherentSum |
IFresnelMap.cpp | Implements class IFresnelMap |
IFresnelMap.h | Defines class IFresnelMap |
MatrixFresnelMap.cpp | Implements class MatrixFresnelMap |
MatrixFresnelMap.h | Defines class MatrixFresnelMap |
ScalarFresnelMap.cpp | Implements class ScalarFresnelMap |
ScalarFresnelMap.h | Defines class ScalarFresnelMap |
► HardParticle | |
FormFactorAnisoPyramid.cpp | Implements class FormFactorAnisoPyramid |
FormFactorAnisoPyramid.h | Defines class FormFactorAnisoPyramid |
FormFactorBar.cpp | Implements classes FormFactorBar* |
FormFactorBar.h | Defines classes FormFactorBar* |
FormFactorBox.cpp | Implements class FormFactorBox |
FormFactorBox.h | Defines class FormFactorBox |
FormFactorCantellatedCube.cpp | Implements class FormFactorCantellatedCube |
FormFactorCantellatedCube.h | Defines class FormFactorCantellatedCube |
FormFactorCone.cpp | Implements class FormFactorCone |
FormFactorCone.h | Defines class FormFactorCone |
FormFactorCone6.cpp | Implements class FormFactorCone6 |
FormFactorCone6.h | Defines class FormFactorCone6 |
FormFactorCosineRipple.cpp | Implements classes FormFactorCosineRipple* |
FormFactorCosineRipple.h | Defines classes FormFactorCosineRipple* |
FormFactorCuboctahedron.cpp | Implements class FormFactorCuboctahedron |
FormFactorCuboctahedron.h | Defines class FormFactorCuboctahedron |
FormFactorCylinder.cpp | Implements class FormFactorCylinder |
FormFactorCylinder.h | Defines class FormFactorCylinder |
FormFactorDodecahedron.cpp | Implements class FormFactorDodecahedron |
FormFactorDodecahedron.h | Defines class FormFactorDodecahedron |
FormFactorDot.cpp | Implements class FormFactorDot |
FormFactorDot.h | Defines class FormFactorDot |
FormFactorEllipsoidalCylinder.cpp | Implements class FormFactorEllipsoidalCylinder |
FormFactorEllipsoidalCylinder.h | Defines class FormFactorEllipsoidalCylinder |
FormFactorFullSphere.cpp | Implements class FormFactorFullSphere |
FormFactorFullSphere.h | Defines class FormFactorFullSphere |
FormFactorFullSpheroid.cpp | Implements class FormFactorFullSpheroid |
FormFactorFullSpheroid.h | Defines class FormFactorFullSpheroid |
FormFactorHemiEllipsoid.cpp | Implements class FormFactorHemiEllipsoid |
FormFactorHemiEllipsoid.h | Defines class FormFactorHemiEllipsoid |
FormFactorHollowSphere.cpp | Implements class FormFactorHollowSphere |
FormFactorHollowSphere.h | Defines class FormFactorHollowSphere |
FormFactorIcosahedron.cpp | Implements class FormFactorIcosahedron |
FormFactorIcosahedron.h | Defines class FormFactorIcosahedron |
FormFactorLongBoxGauss.cpp | Implements class FormFactorLongBoxGauss |
FormFactorLongBoxGauss.h | Defines class FormFactorLongBoxGauss |
FormFactorLongBoxLorentz.cpp | Implements class FormFactorLongBoxLorentz |
FormFactorLongBoxLorentz.h | Defines class FormFactorLongBoxLorentz |
FormFactorPrism3.cpp | Implements class FormFactorPrism3 |
FormFactorPrism3.h | Defines class FormFactorPrism3 |
FormFactorPrism6.cpp | Implements class FormFactorPrism6 |
FormFactorPrism6.h | Defines class FormFactorPrism6 |
FormFactorPyramid.cpp | Implements class FormFactorPyramid |
FormFactorPyramid.h | Defines class FormFactorPyramid |
FormFactorSawtoothRipple.cpp | Implements classes FormFactorSawtoothRipple* |
FormFactorSawtoothRipple.h | Defines classes FormFactorSawtoothRipple* |
FormFactorTetrahedron.cpp | Implements class FormFactorTetrahedron |
FormFactorTetrahedron.h | Defines class FormFactorTetrahedron |
FormFactorTruncatedCube.cpp | Implements class FormFactorTruncatedCube |
FormFactorTruncatedCube.h | Defines class FormFactorTruncatedCube |
FormFactorTruncatedSphere.cpp | Implements class FormFactorTruncatedSphere |
FormFactorTruncatedSphere.h | Defines class FormFactorTruncatedSphere |
FormFactorTruncatedSpheroid.cpp | Implements class FormFactorTruncatedSpheroid |
FormFactorTruncatedSpheroid.h | Defines class FormFactorTruncatedSpheroid |
HardParticles.h | Includes all particle-shape form-factor definitions |
IFormFactorPolyhedron.cpp | Implements class IFormFactorPolyhedron |
IFormFactorPolyhedron.h | Defines class IFormFactorPolyhedron |
IFormFactorPrism.cpp | Implements class IFormFactorPrism |
IFormFactorPrism.h | Defines class IFormFactorPrism |
IProfileRipple.cpp | Implements class ISawtoothRipple |
IProfileRipple.h | Defines interface classes IProfileRipple, ICosineRipple, ISawtoothRipple |
PolyhedralComponents.cpp | Implements classes PolyhedralEdge, PolyhedralFace |
PolyhedralComponents.h | Defines classes PolyhedralEdge, PolyhedralFace |
PolyhedralTopology.h | Defines classes PolygonalTopology, PolyhedralTopology |
Polyhedron.cpp | Implements class Polyhedron |
Polyhedron.h | Defines class Polyhedron |
Prism.cpp | Implements class Prism |
Prism.h | Defines class Prism |
Ripples.cpp | Implements computations in namespace ripples |
Ripples.h | Declares computations in namespace ripples |
► Interference | |
DecouplingApproximationStrategy.cpp | Implements class DecouplingApproximationStrategy |
DecouplingApproximationStrategy.h | Defines class DecouplingApproximationStrategy |
IInterferenceFunctionStrategy.cpp | Implements default behaviour of IInterferenceFunctionStrategy |
IInterferenceFunctionStrategy.h | Defines class IInterferenceFunctionStrategy |
InterferenceFunctionUtils.cpp | Implements helper functions for InterferenceFunctions and Strategies |
InterferenceFunctionUtils.h | Defines helper functions for InterferenceFunctions and Strategies |
SSCAHelper.cpp | Implements class SSCAHelper |
SSCAHelper.h | Defines class SSCAHelper |
SSCApproximationStrategy.cpp | Implements class SSCApproximationStrategy |
SSCApproximationStrategy.h | Defines class SSCApproximationStrategy |
► Lattice | |
ILatticeOrientation.cpp | Implements subclasses of ILatticeOrientation |
ILatticeOrientation.h | Defines interface ILatticeOrientation and subclasses |
ISelectionRule.h | Defines classes ISelectionRule, SimpleSelectionRule |
Lattice.cpp | Implements class Lattice |
Lattice.h | Defines class Lattice |
Lattice2D.cpp | Implements classes of Lattice2D family |
Lattice2D.h | Defines classes of Lattice2D family |
LatticeUtils.cpp | Implements factory functions for different types of lattices and orientations |
LatticeUtils.h | Defines factory functions for different types of lattices and orientations |
► LibFF | |
SomeFormFactors.cpp | Implements namespace someff with some form factor functions |
SomeFormFactors.h | Declares namespace someff with some form factor functions |
► Material | |
BaseMaterialImpl.h | Defines basic material implementation interface |
MagneticMaterialImpl.cpp | Implements magnetic material base implementation |
MagneticMaterialImpl.h | Defines magnetic material base implementation |
Material.cpp | Implements and implements class Material |
Material.h | Defines and implements class Material |
MaterialBySLDImpl.cpp | Implements class MaterialBySLDImpl |
MaterialBySLDImpl.h | Defines class MaterialBySLDImpl |
MaterialFactoryFuncs.cpp | Factory functions used to create material instances |
MaterialFactoryFuncs.h | Factory functions used to create material instances |
MaterialUtils.cpp | Implements functions in namespace MaterialUtils |
MaterialUtils.h | Declares functions in namespace MaterialUtils |
RefractiveMaterialImpl.cpp | Implements class RefractiveMaterialImpl |
RefractiveMaterialImpl.h | Defines class RefractiveMaterialImpl |
WavevectorInfo.cpp | Implements WavevectorInfo |
WavevectorInfo.h | Defines WavevectorInfo |
► Multilayer | |
Layer.cpp | Implements class Layer |
Layer.h | Defines class Layer |
MultiLayer.cpp | Implements class MultiLayer |
MultiLayer.h | Defines class MultiLayer |
MultiLayerUtils.cpp | Implements helper functions for MultiLayer objects |
MultiLayerUtils.h | Defines helper functions for MultiLayer objects |
PyImport.cpp | Implements PyImport namespace |
PyImport.h | Defines PyImport namespace |
RoughnessModels.cpp | Implements RoughnessModels enumerator and Python wrapper |
RoughnessModels.h | Define RoughnessModels enumerator and Python wrapper |
► Particle | |
Crystal.cpp | Implements class Crystal |
Crystal.h | Defines class Crystal |
FormFactorCoreShell.cpp | Implements class FormFactorCoreShell |
FormFactorCoreShell.h | Defines class FormFactorCoreShell |
FormFactorCrystal.cpp | Implements class FormFactorCrystal |
FormFactorCrystal.h | Defines class FormFactorCrystal |
FormFactorWeighted.cpp | Implements class FormFactorWeighted |
FormFactorWeighted.h | Defines class FormFactorWeighted |
HomogeneousRegion.cpp | Implements fct createAveragedMaterial |
HomogeneousRegion.h | Defines struct HomogeneousRegion, and declares fct createAveragedMaterial |
IAbstractParticle.cpp | Defines interface IAParticle |
IAbstractParticle.h | Defines interface IAbstractParticle |
IClusteredParticles.h | Defines class IClusteredParticles |
IParticle.cpp | Implements interface IParticle |
IParticle.h | Defines interface IParticle |
MesoCrystal.cpp | Implements class MesoCrystal |
MesoCrystal.h | Defines class MesoCrystal |
Particle.cpp | Implements class Particle |
Particle.h | Defines class Particle |
ParticleComposition.cpp | Implements class ParticleComposition |
ParticleComposition.h | Defines class ParticleComposition |
ParticleCoreShell.cpp | Implements class ParticleCoreShell |
ParticleCoreShell.h | Defines ParticleCoreShell |
ParticleDistribution.cpp | Implements class ParticleDistribution |
ParticleDistribution.h | Defines class ParticleDistribution |
SlicedParticle.h | Defines class SlicedParticle |
TRange.h | Defines and implements template classes TRange and TSampledRange |
► RT | |
ILayerRTCoefficients.h | Defines and implements class ILayerRTCoefficients |
MatrixRTCoefficients.cpp | Implements class MatrixRTCoefficients |
MatrixRTCoefficients.h | Defines class MatrixRTCoefficients |
MatrixRTCoefficients_v2.cpp | Implements class MatrixRTCoefficients_v2 |
MatrixRTCoefficients_v2.h | Defines class MatrixRTCoefficients_v2 |
MatrixRTCoefficients_v3.cpp | Implements class MatrixRTCoefficients_v3 |
MatrixRTCoefficients_v3.h | Defines class MatrixRTCoefficients_v3 |
ScalarRTCoefficients.h | Defines class ScalarRTCoefficients |
SimulationOptions.cpp | Implements class SimulationOptions |
SimulationOptions.h | Defines class SimulationOptions |
► SampleBuilderEngine | |
FixedBuilder.cpp | Implements class FixedBuilder |
FixedBuilder.h | Defines class FixedBuilder |
IRegistry.h | Defines templated registry for ICloneable objects |
ISampleBuilder.cpp | Implements pure virtual base class ISampleBuilder |
ISampleBuilder.h | Defines pure virtual base class ISampleBuilder |
SampleBuilderNode.cpp | Implements class SampleBuilderNode |
SampleBuilderNode.h | Defines class SampleBuilderNode |
SampleComponents.cpp | Implements sample components for complex sample builders |
SampleComponents.h | Defines sample components for complex sample builders |
SampleProvider.cpp | Implements class SampleProvider |
SampleProvider.h | Defines class SampleProvider |
► Scattering | |
FormFactorBAPol.cpp | Defines class FormFactorBAPol |
FormFactorBAPol.h | Defines class FormFactorBAPol |
FormFactorDecoratorMaterial.cpp | Implements class FormFactorDecoratorMaterial |
FormFactorDecoratorMaterial.h | Defines class FormFactorDecoratorMaterial |
FormFactorDecoratorPositionFactor.cpp | Implements class FormFactorDecoratorPositionFactor |
FormFactorDecoratorPositionFactor.h | Defines class FormFactorDecoratorPositionFactor |
FormFactorDecoratorRotation.cpp | Implements class FormFactorDecoratorRotation |
FormFactorDecoratorRotation.h | Defines class FormFactorDecoratorRotation |
FormFactorDWBA.cpp | Implements class FormFactorDWBA |
FormFactorDWBA.h | Defines class FormFactorDWBA |
FormFactorDWBAPol.cpp | Defines class FormFactorDWBAPol |
FormFactorDWBAPol.h | Defines class FormFactorDWBAPol |
IFormFactor.cpp | Implements interface class IFormFactor |
IFormFactor.h | Defines and implements pure virtual interface IFormFactor |
IFormFactorBorn.cpp | Implements interface class IFormFactorBorn |
IFormFactorBorn.h | Defines pure virtual interface class IFormFactorBorn |
IFormFactorDecorator.h | Defines and implements pure virtual interface class IFormFactorDecorator |
ISample.cpp | Implements class ISample |
ISample.h | Defines interface class ISample |
LayerFillLimits.cpp | Implements class LayerFillLimits |
LayerFillLimits.h | Defines class LayerFillLimits |
Rotations.cpp | Implements IRotation classes |
Rotations.h | Defines IRotation classes |
ZLimits.cpp | Defines class ZLimits |
ZLimits.h | Defines class ZLimits |
► Shapes | |
Box.cpp | Implements class Box |
Box.h | Defines class Box |
DoubleEllipse.cpp | Implements class DoubleEllipse |
DoubleEllipse.h | Defines class DoubleEllipse |
IShape.cpp | Implements default methods of interface IShape |
IShape.h | Defines interface IShape |
RippleCosine.cpp | Implements class RippleCosine |
RippleCosine.h | Defines class RippleCosine |
RippleSawtooth.cpp | Implements class RippleSawtooth |
RippleSawtooth.h | Defines class RippleSawtooth |
TruncatedEllipsoid.cpp | Implements class TruncatedEllipsoid |
TruncatedEllipsoid.h | Defines class TruncatedEllipsoid |
► Slice | |
KzComputation.cpp | Implements functions in namespace KzComputation |
KzComputation.h | Declares functions in namespace KzComputation |
LayerInterface.cpp | Implements class LayerInterface |
LayerInterface.h | Defines class LayerInterface |
LayerRoughness.cpp | Implements class LayerRoughness |
LayerRoughness.h | Defines class LayerRoughness |
Slice.cpp | Implements class Slice |
Slice.h | Defines class Slice |
SlicedFormFactorList.cpp | Defines class SlicedFormFactorList |
SlicedFormFactorList.h | Defines class SlicedFormFactorList |
SpecularSimulationElement.cpp | Implements the class SpecularSimulationElement |
SpecularSimulationElement.h | Declares the class SpecularSimulationElement |
► SoftParticle | |
FormFactorGauss.cpp | Implements class FormFactorGaussSphere |
FormFactorGauss.h | Defines class FormFactorGaussSphere |
FormFactorSphereGaussianRadius.cpp | Implements class FormFactorSphereGaussianRadius |
FormFactorSphereGaussianRadius.h | Defines and implements class FormFactorSphereGaussianRadius |
FormFactorSphereLogNormalRadius.cpp | Implements class FormFactorSphereGaussianRadius |
FormFactorSphereLogNormalRadius.h | Defines and implements class FormFactorSphereLogNormalRadius |
SoftParticles.h | Includes all soft-particle form-factor definitions |
► Specular | |
ISpecularStrategy.h | Defines and implements class ISpecularStrategy |
SpecularMagneticNewNCStrategy.cpp | Implements class SpecularMagneticNewNCStrategy |
SpecularMagneticNewNCStrategy.h | Defines class SpecularMagneticNewNCStrategy |
SpecularMagneticNewStrategy.cpp | Implements class SpecularMagneticNewStrategy |
SpecularMagneticNewStrategy.h | Defines class SpecularMagneticNewStrategy |
SpecularMagneticNewTanhStrategy.cpp | Implements class SpecularMagneticNewTanhStrategy |
SpecularMagneticNewTanhStrategy.h | Defines class SpecularMagneticNewTanhStrategy |
SpecularMagneticOldStrategy.cpp | Implements class SpecularMagneticOldStrategy |
SpecularMagneticOldStrategy.h | Defines class SpecularMagneticOldStrategy |
SpecularMagneticStrategy.cpp | Implements class SpecularMagneticStrategy |
SpecularMagneticStrategy.h | Defines class SpecularMagneticStrategy |
SpecularScalarNCStrategy.cpp | Implements class SpecularScalarNCStrategy |
SpecularScalarNCStrategy.h | Defines class SpecularScalarNCStrategy |
SpecularScalarStrategy.cpp | Implements class SpecularScalarStrategy |
SpecularScalarStrategy.h | Defines class SpecularScalarStrategy |
SpecularScalarTanhStrategy.cpp | Implements class SpecularScalarTanhStrategy |
SpecularScalarTanhStrategy.h | Defines class SpecularScalarTanhStrategy |
► StandardSamples | |
BoxCompositionBuilder.cpp | Implements class BoxCompositionBuilder |
BoxCompositionBuilder.h | Defines classes of BoxCompositionBuilder family |
BoxesSquareLatticeBuilder.cpp | Implements class BoxesSquareLatticeBuilder |
BoxesSquareLatticeBuilder.h | Defines class BoxesSquareLatticeBuilder |
CoreShellParticleBuilder.cpp | Implements class CoreShellParticleBuilder |
CoreShellParticleBuilder.h | Defines class CoreShellParticleBuilder |
CustomMorphologyBuilder.cpp | Implements class CustomMorphologyBuilder |
CustomMorphologyBuilder.h | Defines class CustomMorphologyBuilder |
CylindersAndPrismsBuilder.cpp | Implements class CylindersAndPrismsBuilder |
CylindersAndPrismsBuilder.h | Defines class CylindersAndPrismsBuilder |
CylindersBuilder.cpp | Implements classes of CylindersBuilder family |
CylindersBuilder.h | Defines classes of CylindersBuilder family |
FeNiBilayerBuilder.cpp | Defines various sample builder classes to test polarized specular computations |
FeNiBilayerBuilder.h | Defines various sample builder classes to test polarized specular computations |
HomogeneousMultilayerBuilder.cpp | Implements class HomogeneousMultilayerBuilder |
HomogeneousMultilayerBuilder.h | Defines class HomogeneousMultilayerBuilder |
LatticeBuilder.cpp | Implements class Lattice1DBuilder |
LatticeBuilder.h | Defines class Lattice1DBuilder |
LayersWithAbsorptionBuilder.cpp | Implements class LayersWithAbsorptionBuilder |
LayersWithAbsorptionBuilder.h | Defines class LayersWithAbsorptionBuilder |
LayersWithAbsorptionBySLDBuilder.cpp | Implements class LayersWithAbsorptionBySLDBuilder |
LayersWithAbsorptionBySLDBuilder.h | Defines class LayersWithAbsorptionBySLDBuilder |
MagneticLayersBuilder.cpp | Implements class to build samples with magnetic layers |
MagneticLayersBuilder.h | Defines class to build samples with magnetic layers |
MagneticParticlesBuilder.cpp | Implements classes to build magnetic samples |
MagneticParticlesBuilder.h | Defines class to build magnetic samples |
MesoCrystalBuilder.cpp | Implements class MesoCrystalBuilder |
MesoCrystalBuilder.h | Defines class MesoCrystalBuilder |
MultiLayerWithNCRoughnessBuilder.cpp | Implement class MultiLayerWithNCRoughnessBuilder |
MultiLayerWithNCRoughnessBuilder.h | Defines class MultiLayerWithNCRoughnessBuilder |
MultiLayerWithRoughnessBuilder.cpp | Implement class MultiLayerWithRoughnessBuilder |
MultiLayerWithRoughnessBuilder.h | Defines class MultiLayerWithRoughnessBuilder |
MultipleLayoutBuilder.cpp | Implements class MultipleLayoutBuilder |
MultipleLayoutBuilder.h | Defines class MultipleLayoutBuilder |
ParaCrystalBuilder.cpp | Implements class ParaCrystalBuilder |
ParaCrystalBuilder.h | Defines classes of ParaCrystalBuilder family |
ParticleCompositionBuilder.cpp | Implements class ParticleCompositionBuilder |
ParticleCompositionBuilder.h | Defines class ParticleCompositionBuilder |
ParticleDistributionsBuilder.cpp | Implements classes of with different types of particle distributions |
ParticleDistributionsBuilder.h | Defines classes of with different types of particle distributions |
ParticleInVacuumBuilder.cpp | Implements class ParticleInVacuumBuilder |
ParticleInVacuumBuilder.h | Defines class ParticleInVacuumBuilder |
PercusYevickBuilder.cpp | Implements class PercusYevickBuilder |
PercusYevickBuilder.h | Defines classes of PercusYevickBuilder family |
PlainMultiLayerBySLDBuilder.cpp | Implements class PlainMultiLayerBySLDBuilder |
PlainMultiLayerBySLDBuilder.h | Declares the class PlainMultiLayerBySLDBuilder |
ReferenceMaterials.h | Defines materials in namespace refMat |
ResonatorBuilder.cpp | Implements ResonatorBuilder class |
ResonatorBuilder.h | Defines ResonatorBuilder class |
RipplesBuilder.cpp | Implement classes to build various ripples |
RipplesBuilder.h | Defines classes to build various ripples |
RotatedPyramidsBuilder.cpp | Implements classe RotatedPyramidsBuilder |
RotatedPyramidsBuilder.h | Defines class RotatedPyramidsBuilder |
SampleBuilderFactory.cpp | Implement class SampleBuilderFactory |
SampleBuilderFactory.h | Defines class SampleBuilderFactory |
SizeDistributionModelsBuilder.cpp | Implements class ParticlesInSSCABuilder |
SizeDistributionModelsBuilder.h | Defines various sample builder classes to test DA, LMA, SSCA approximations |
SlicedCompositionBuilder.cpp | Defines classes to build various particles crossing interfaces |
SlicedCompositionBuilder.h | Defines classes to build various particles crossing interfaces |
SlicedCylindersBuilder.cpp | Implements classes for testing slicing machinery |
SlicedCylindersBuilder.h | Defines classes for testing slicing machinery |
ThickAbsorptiveSampleBuilder.cpp | Implements class to build thick highly-absorptive sample with roughness |
ThickAbsorptiveSampleBuilder.h | Defines class to build thick highly-absorptive sample with roughness |
TransformationsBuilder.cpp | Implements classes to build samples with different transformations |
TransformationsBuilder.h | Defines classes to build samples with different transformations |
TwoDimLatticeBuilder.cpp | Implements class IsGISAXS06Builder |
TwoDimLatticeBuilder.h | Defines class IsGISAXS06Builder |
TwoLayerRoughnessBuilder.cpp | Implement class TwoLayerRoughnessBuilder |
TwoLayerRoughnessBuilder.h | Defines class TwoLayerRoughnessBuilder |