Skip to content
Snippets Groups Projects
Commit 59994ae6 authored by pospelov's avatar pospelov
Browse files

Static code analysis: fixes for constness, level of private/protected

parent 8187679a
No related branches found
No related tags found
No related merge requests found
Showing
with 51 additions and 43 deletions
......@@ -27,7 +27,7 @@ public:
void setCutoff(double cutoff) {
if (cutoff>=0.0 && cutoff<=1.0) m_cutoff = cutoff;
}
double getCutoff() { return m_cutoff; }
double getCutoff() const { return m_cutoff; }
//! return output data which contains chi^2 values
virtual OutputData<double > *createChi2DifferenceMap() const;
......
......@@ -43,7 +43,7 @@ private:
void diffuse_crosscorr();
complex_t get_refractive_term(size_t ilayer);
complex_t get_refractive_term(size_t ilayer) const;
complex_t get_sum4terms(size_t ilayer);
......
......@@ -29,7 +29,7 @@ public:
virtual double evaluate(const cvector_t &k_i, const Bin1DCVector &k_f_bin,
double alpha_i, double alpha_f) const;
private:
bool checkVectorSizes();
bool checkVectorSizes() const;
};
......
......@@ -56,7 +56,7 @@ private:
void swapContent(Detector &other);
//! initialize axis the way IsGISAXS does
void initializeAnglesIsgisaxs(AxisDouble *p_axis, const TSampledRange<double> &axis_range);
void initializeAnglesIsgisaxs(AxisDouble *p_axis, const TSampledRange<double> &axis_range) const;
SafePointerVector<IAxis> m_axes;
IDetectorResolution *mp_detector_resolution;
......
......@@ -38,8 +38,8 @@ public:
virtual IFTDistribution2D *clone() const=0;
double getGamma() { return m_gamma; }
double getDelta() { return m_delta; }
double getGamma() const { return m_gamma; }
double getDelta() const { return m_delta; }
virtual double evaluate(double qx, double qy) const=0;
protected:
double m_omega_x;
......
......@@ -55,10 +55,12 @@ protected:
GISASExperiment(const GISASExperiment &other);
GISASExperiment &operator=(const GISASExperiment &);
private:
//! initialize pool parameters, i.e. register some of class members for later access via parameter pool
virtual void init_parameters();
private:
double getSolidAngle(size_t index) const;
double deltaAlpha(double alpha, double zeta) const;
double deltaPhi(double alpha, double phi, double zeta) const;
......
......@@ -16,7 +16,7 @@
#include "MaskCoordinateFunction.h"
#include <cstddef>
//#include <cstddef>
//- -------------------------------------------------------------------
//! @class Mask
......@@ -59,8 +59,10 @@ public:
virtual ~MaskIndexModulus() {}
virtual MaskIndexModulus *clone() const;
private:
protected:
virtual bool isMasked(size_t total_index) const;
private:
size_t m_modulus;
size_t m_remainder;
};
......@@ -78,8 +80,10 @@ public:
void setMaskCoordinateFunction(MaskCoordinateFunction *p_mask_function);
private:
protected:
virtual bool isMasked(size_t total_index) const;
private:
void setCachedCoordinates(size_t index) const;
size_t m_rank;
int *m_dims;
......
......@@ -71,13 +71,13 @@ public:
private:
bool m_use_roughness;
void calculateKZ(const MultiLayer &sample, const kvector_t &k, MultiLayerCoeff_t &coeff);
void calculateFresnelCoefficients(MultiLayerCoeff_t &coeff);
void calculateFresnelCoefficientsWithRoughness(const MultiLayer &sample, MultiLayerCoeff_t &coeff);
void calculateX(const MultiLayer &sample, MultiLayerCoeff_t &coeff);
void calculateX2(const MultiLayer &sample, MultiLayerCoeff_t &coeff);
void calculateRT(const MultiLayer &sample, MultiLayerCoeff_t &coeff);
void calculateRT2(const MultiLayer &sample, MultiLayerCoeff_t &coeff);
void calculateKZ(const MultiLayer &sample, const kvector_t &k, MultiLayerCoeff_t &coeff) const;
void calculateFresnelCoefficients(MultiLayerCoeff_t &coeff) const;
void calculateFresnelCoefficientsWithRoughness(const MultiLayer &sample, MultiLayerCoeff_t &coeff) const;
void calculateX(const MultiLayer &sample, MultiLayerCoeff_t &coeff) const;
void calculateX2(const MultiLayer &sample, MultiLayerCoeff_t &coeff) const;
void calculateRT(const MultiLayer &sample, MultiLayerCoeff_t &coeff) const;
void calculateRT2(const MultiLayer &sample, MultiLayerCoeff_t &coeff) const;
};
......
......@@ -77,7 +77,7 @@ void DWBADiffuseReflection::diffuse_crosscorr()
}
complex_t DWBADiffuseReflection::get_refractive_term(size_t ilayer)
complex_t DWBADiffuseReflection::get_refractive_term(size_t ilayer) const
{
complex_t n1 = m_sample->getLayer(ilayer)->getRefractiveIndex();
complex_t n2 = m_sample->getLayer(ilayer+1)->getRefractiveIndex();
......
......@@ -32,7 +32,7 @@ double DecouplingApproximationStrategy::evaluate(const cvector_t& k_i,
return intensity + amplitude_norm*(itf_function-1.0);
}
bool DecouplingApproximationStrategy::checkVectorSizes()
bool DecouplingApproximationStrategy::checkVectorSizes() const
{
size_t n_ffs = m_form_factors.size();
size_t n_frs = m_fractions.size();
......
......@@ -120,7 +120,7 @@ void Detector::init_parameters()
{
}
void Detector::initializeAnglesIsgisaxs(AxisDouble* p_axis, const TSampledRange<double>& axis_range)
void Detector::initializeAnglesIsgisaxs(AxisDouble* p_axis, const TSampledRange<double>& axis_range) const
{
double start_sin = std::sin(axis_range.getMin());
double end_sin = std::sin(axis_range.getMax());
......
......@@ -38,7 +38,7 @@ void OpticalFresnel::execute(const MultiLayer &sample, const kvector_t &kvec, Mu
}
void OpticalFresnel::calculateKZ(const MultiLayer &sample, const kvector_t &kvec, MultiLayerCoeff_t &coeff)
void OpticalFresnel::calculateKZ(const MultiLayer &sample, const kvector_t &kvec, MultiLayerCoeff_t &coeff) const
{
// z-component of reflected wave vector inside each layer
// Q_{z,j} &= 2k_{z,j} = 2\cdot \sqrt{ k^2 n_j^2 - k_x^2 }
......@@ -50,7 +50,7 @@ void OpticalFresnel::calculateKZ(const MultiLayer &sample, const kvector_t &kvec
}
}
void OpticalFresnel::calculateFresnelCoefficients(MultiLayerCoeff_t &coeff)
void OpticalFresnel::calculateFresnelCoefficients(MultiLayerCoeff_t &coeff) const
{
// calculation of reflection/transmission Fresnel coefficients
for(size_t i=0; i<coeff.size() - 1; i++) {
......@@ -76,7 +76,7 @@ void OpticalFresnel::calculateFresnelCoefficients(MultiLayerCoeff_t &coeff)
}
void OpticalFresnel::calculateFresnelCoefficientsWithRoughness(const MultiLayer &sample, MultiLayerCoeff_t &coeff)
void OpticalFresnel::calculateFresnelCoefficientsWithRoughness(const MultiLayer &sample, MultiLayerCoeff_t &coeff) const
{
double picoeff = std::pow(M_PI/2., 1.5);
......@@ -115,7 +115,7 @@ void OpticalFresnel::calculateFresnelCoefficientsWithRoughness(const MultiLayer
}
void OpticalFresnel::calculateX(const MultiLayer &sample, MultiLayerCoeff_t &coeff)
void OpticalFresnel::calculateX(const MultiLayer &sample, MultiLayerCoeff_t &coeff) const
{
// ratio of amplitudes of outgoing and incoming waves
coeff[coeff.size()-1].X = complex_t(0, 0);
......@@ -127,7 +127,7 @@ void OpticalFresnel::calculateX(const MultiLayer &sample, MultiLayerCoeff_t &coe
}
}
void OpticalFresnel::calculateX2(const MultiLayer &sample, MultiLayerCoeff_t &coeff)
void OpticalFresnel::calculateX2(const MultiLayer &sample, MultiLayerCoeff_t &coeff) const
{
// ratio of amplitudes of outgoing and incoming waves in alternative conventions
coeff[coeff.size()-1].X = complex_t(0, 0);
......@@ -149,7 +149,7 @@ void OpticalFresnel::calculateX2(const MultiLayer &sample, MultiLayerCoeff_t &co
}
}
void OpticalFresnel::calculateRT(const MultiLayer &sample, MultiLayerCoeff_t &coeff)
void OpticalFresnel::calculateRT(const MultiLayer &sample, MultiLayerCoeff_t &coeff) const
{
coeff[0].R = coeff[0].X;
coeff[0].T = 1;
......@@ -163,7 +163,7 @@ void OpticalFresnel::calculateRT(const MultiLayer &sample, MultiLayerCoeff_t &co
}
}
void OpticalFresnel::calculateRT2(const MultiLayer &sample, MultiLayerCoeff_t &coeff)
void OpticalFresnel::calculateRT2(const MultiLayer &sample, MultiLayerCoeff_t &coeff) const
{
//complex_t ct0(0,0);
......
......@@ -31,7 +31,7 @@ public:
virtual FormFactorCrystal *clone() const;
virtual void setAmbientRefractiveIndex(complex_t refractive_index);
virtual void setAmbientRefractiveIndex(const complex_t &refractive_index);
virtual complex_t evaluate(const cvector_t &k_i, const Bin1DCVector &k_f_bin, double alpha_i, double alpha_f) const;
......
......@@ -32,14 +32,15 @@ public:
virtual complex_t evaluate_for_q(const cvector_t &q) const;
protected:
//! initialize pool parameters, i.e. register some of class members for later access via parameter pool
virtual void init_parameters();
private:
FormFactorCylinder(const FormFactorCylinder &);
FormFactorCylinder &operator=(const FormFactorCylinder &);
//! initialize pool parameters, i.e. register some of class members for later access via parameter pool
virtual void init_parameters();
// //! print class
// void print(std::ostream &ostr) const;
......
......@@ -20,7 +20,7 @@
class FormFactorDecoratorFactor : public IFormFactorDecorator
{
public:
FormFactorDecoratorFactor(IFormFactor *p_form_factor, complex_t factor);
FormFactorDecoratorFactor(IFormFactor *p_form_factor, const complex_t &factor);
virtual FormFactorDecoratorFactor *clone() const;
virtual ~FormFactorDecoratorFactor() {}
......@@ -37,7 +37,7 @@ private:
};
inline FormFactorDecoratorFactor::FormFactorDecoratorFactor(
IFormFactor* p_form_factor, complex_t factor)
IFormFactor* p_form_factor, const complex_t &factor)
: IFormFactorDecorator(p_form_factor)
, m_factor(factor)
{
......
......@@ -19,23 +19,23 @@
class FormFactorDecoratorRefractiveIndex : public FormFactorDecoratorFactor
{
public:
FormFactorDecoratorRefractiveIndex(IFormFactor *p_form_factor, complex_t refractive_index);
FormFactorDecoratorRefractiveIndex(IFormFactor *p_form_factor, const complex_t &refractive_index);
~FormFactorDecoratorRefractiveIndex();
FormFactorDecoratorRefractiveIndex *clone() const;
virtual void setAmbientRefractiveIndex(complex_t ambient_refractive_index);
virtual void setAmbientRefractiveIndex(const complex_t &ambient_refractive_index);
private:
FormFactorDecoratorRefractiveIndex(const FormFactorDecoratorRefractiveIndex &);
FormFactorDecoratorRefractiveIndex &operator=(const FormFactorDecoratorRefractiveIndex &);
complex_t getRefractiveIndexFactor(complex_t ambient_index, complex_t particle_index);
complex_t getRefractiveIndexFactor(const complex_t &ambient_index, const complex_t &particle_index);
complex_t m_refractive_index;
};
inline FormFactorDecoratorRefractiveIndex::FormFactorDecoratorRefractiveIndex(
IFormFactor* p_form_factor, complex_t refractive_index)
IFormFactor* p_form_factor, const complex_t &refractive_index)
: FormFactorDecoratorFactor(p_form_factor,
getRefractiveIndexFactor(complex_t(1.0, 0.0), refractive_index))
, m_refractive_index(refractive_index)
......@@ -56,13 +56,13 @@ inline FormFactorDecoratorRefractiveIndex* FormFactorDecoratorRefractiveIndex::c
}
inline void FormFactorDecoratorRefractiveIndex::setAmbientRefractiveIndex(
complex_t ambient_refractive_index)
const complex_t &ambient_refractive_index)
{
m_factor = getRefractiveIndexFactor(ambient_refractive_index, m_refractive_index);
}
inline complex_t FormFactorDecoratorRefractiveIndex::getRefractiveIndexFactor(
complex_t ambient_index, complex_t particle_index)
const complex_t &ambient_index, const complex_t &particle_index)
{
return (ambient_index*ambient_index - particle_index*particle_index);
}
......
......@@ -38,9 +38,10 @@ public:
virtual double getHeight() const { return m_height; }
protected:
virtual complex_t evaluate_for_q(const cvector_t &q) const;
protected:
//! initialize pool parameters, i.e. register some of class members for later access via parameter pool
virtual void init_parameters();
......
......@@ -25,7 +25,7 @@ public:
void addFormFactor(const IFormFactor &form_factor, double weight=1.0);
virtual void setAmbientRefractiveIndex(complex_t refractive_index);
virtual void setAmbientRefractiveIndex(const complex_t &refractive_index);
virtual complex_t evaluate(const cvector_t &k_i, const Bin1DCVector &k_f_bin, double alpha_i, double alpha_f) const;
......
......@@ -37,7 +37,7 @@ public:
virtual IFormFactor *clone() const=0;
//! pass the refractive index of the ambient material in which this particle is embedded
virtual void setAmbientRefractiveIndex(complex_t refractive_index) { (void)refractive_index; }
virtual void setAmbientRefractiveIndex(const complex_t &refractive_index) { (void)refractive_index; }
//! calculate scattering amplitude for complex wavevector bin
//! @param k_i incoming wavevector
......
......@@ -30,7 +30,7 @@ public:
virtual ~IFormFactorDecorator();
virtual IFormFactorDecorator *clone() const=0;
virtual void setAmbientRefractiveIndex(complex_t refractive_index);
virtual void setAmbientRefractiveIndex(const complex_t &refractive_index);
virtual double getVolume() const;
......@@ -47,7 +47,7 @@ inline IFormFactorDecorator::~IFormFactorDecorator()
delete mp_form_factor;
}
inline void IFormFactorDecorator::setAmbientRefractiveIndex(complex_t refractive_index)
inline void IFormFactorDecorator::setAmbientRefractiveIndex(const complex_t &refractive_index)
{
if (mp_form_factor) mp_form_factor->setAmbientRefractiveIndex(refractive_index);
}
......
0% Loading or .
You are about to add 0 people to the discussion. Proceed with caution.
Finish editing this message first!
Please register or to comment