diff --git a/Core/Algorithms/inc/GISASExperiment.h b/Core/Algorithms/inc/GISASExperiment.h
index 1a9e8b919c3026f99cb663113582c02aafec9889..2886b53ba37ced2980106bd21e365faba5bf54d0 100644
--- a/Core/Algorithms/inc/GISASExperiment.h
+++ b/Core/Algorithms/inc/GISASExperiment.h
@@ -24,7 +24,7 @@ class GISASExperiment : public Experiment
 {
 public:
     GISASExperiment();
-    GISASExperiment(ProgramOptions *p_options);
+    GISASExperiment(const ProgramOptions *p_options);
 
     virtual ~GISASExperiment() {}
 
@@ -61,8 +61,8 @@ private:
 
 	double getSolidAngle(size_t index) const;
 	double deltaAlpha(double alpha, double zeta) const;
-	double deltaPhi(double alpha, double phi, double zeta);
-	void createZetaAndProbVectors(std::vector<double> &zetas, std::vector<double> &probs, size_t nbr_zetas, double zeta_sigma);
+    double deltaPhi(double alpha, double phi, double zeta) const;
+    void createZetaAndProbVectors(std::vector<double> &zetas, std::vector<double> &probs, size_t nbr_zetas, double zeta_sigma) const;
 	void addToIntensityMap(double alpha, double phi, double value);
 };
 
diff --git a/Core/Algorithms/inc/IFittingDataSelector.h b/Core/Algorithms/inc/IFittingDataSelector.h
index 4702114b3aaa00f987ddc08660089a3f5b9cf4f3..2ed94f9e9dd4f930229592fd5d6b3af046589698 100644
--- a/Core/Algorithms/inc/IFittingDataSelector.h
+++ b/Core/Algorithms/inc/IFittingDataSelector.h
@@ -16,7 +16,7 @@
 
 #include "OutputData.h"
 
-#include <vector>
+//#include <vector>
 
 class IFittingDataSelector
 {
diff --git a/Core/Algorithms/inc/IIntensityFunction.h b/Core/Algorithms/inc/IIntensityFunction.h
index 81145ba42d6d205919e6346d18ffb165fd61150f..2619d3c5fc0a53f13261790eb75eb8a2aa510586 100644
--- a/Core/Algorithms/inc/IIntensityFunction.h
+++ b/Core/Algorithms/inc/IIntensityFunction.h
@@ -31,7 +31,7 @@ class IntensityFunctionLog : public IIntensityFunction
 public:
     virtual ~IntensityFunctionLog() {}
     virtual IntensityFunctionLog *clone() const { return new IntensityFunctionLog(); }
-    virtual inline double evaluate(double value) const { return (value > 0 ? std::log(value) : 0); }
+    virtual double evaluate(double value) const { return (value > 0 ? std::log(value) : 0); }
 };
 
 
diff --git a/Core/Algorithms/inc/ISquaredFunction.h b/Core/Algorithms/inc/ISquaredFunction.h
index 9123d61da7cc65317278af832760cdf61122fc35..032baf32da486a93d96ea89854cd1f0378ddf317 100644
--- a/Core/Algorithms/inc/ISquaredFunction.h
+++ b/Core/Algorithms/inc/ISquaredFunction.h
@@ -17,7 +17,7 @@
 #include "Numeric.h"
 #include "Exceptions.h"
 
-#include <cmath>
+//#include <cmath>
 #include <iostream>
 
 
@@ -39,7 +39,7 @@ public:
     virtual ~SquaredFunctionDefault() {}
     virtual SquaredFunctionDefault *clone() const { return new SquaredFunctionDefault(); }
 
-    virtual inline double calculateSquaredDifference(double real_value, double simulated_value) const
+    virtual double calculateSquaredDifference(double real_value, double simulated_value) const
     {
         double diff_squared = (simulated_value-real_value)*(simulated_value-real_value);
         if (diff_squared < Numeric::double_epsilon) {
@@ -49,7 +49,7 @@ public:
         return diff_squared/sigma_squared;
     }
 
-    virtual inline double calculateSquaredError(double real_value, double /* simulated_value */) const
+    virtual double calculateSquaredError(double real_value, double /* simulated_value */) const
     {
         return std::max(real_value,1.0);
     }
@@ -64,7 +64,7 @@ public:
     virtual ~SquaredFunctionWhichOnlyWorks() {}
     virtual SquaredFunctionWhichOnlyWorks *clone() const { return new SquaredFunctionWhichOnlyWorks(*this); }
 
-    virtual inline double calculateSquaredDifference(double real_value, double simulated_value) const
+    virtual double calculateSquaredDifference(double real_value, double simulated_value) const
     {
         double diff_squared = (simulated_value-real_value)*(simulated_value-real_value);
         if (diff_squared < Numeric::double_epsilon) {
@@ -86,12 +86,12 @@ public:
     virtual ~SquaredFunctionWithSystematicError() {}
     virtual SquaredFunctionWithSystematicError *clone() const { return new SquaredFunctionWithSystematicError(*this); }
 
-    virtual inline double calculateSquaredDifference(double real_value, double simulated_value) const
+    virtual double calculateSquaredDifference(double real_value, double simulated_value) const
     {
         double diff_squared = (simulated_value-real_value)*(simulated_value-real_value);
         return diff_squared/calculateSquaredError(real_value);
     }
-    virtual inline double calculateSquaredError(double real_value, double simulated_value  = 0.0) const
+    virtual double calculateSquaredError(double real_value, double simulated_value  = 0.0) const
     {
         (void)simulated_value;
         return std::max(std::fabs(real_value) + (m_epsilon*real_value)*(m_epsilon*real_value),1.0);
@@ -109,13 +109,13 @@ public:
     virtual ~SquaredFunctionWithGaussianError() {}
     virtual SquaredFunctionWithGaussianError *clone() const { return new SquaredFunctionWithGaussianError(*this); }
 
-    virtual inline double calculateSquaredDifference(double real_value, double simulated_value) const
+    virtual double calculateSquaredDifference(double real_value, double simulated_value) const
     {
         double diff_squared = (simulated_value-real_value)*(simulated_value-real_value);
         double sigma_squared = m_sigma*m_sigma;
         return diff_squared/sigma_squared;
     }
-    virtual inline double calculateSquaredError(double /* real_value */, double /* simulated_value */) const
+    virtual double calculateSquaredError(double /* real_value */, double /* simulated_value */) const
     {
         return m_sigma*m_sigma;
     }
diff --git a/Core/Algorithms/inc/LayerDWBASimulation.h b/Core/Algorithms/inc/LayerDWBASimulation.h
index dbc8de41660df0642e19a86c43fab1989536d85f..ec410c9f8e7c487298b93a5929d9fa3b96c6cbe8 100644
--- a/Core/Algorithms/inc/LayerDWBASimulation.h
+++ b/Core/Algorithms/inc/LayerDWBASimulation.h
@@ -28,7 +28,7 @@ public:
    void setKzAndRTFunctions(const IDoubleToComplexMap &kz_function, const IDoubleToPairOfComplexMap &rt_map);
 
 protected:
-   Bin1DCVector getKfBin(double wavelength, const Bin1D &alpha_bin, const Bin1D &phi_bin);
+   Bin1DCVector getKfBin(double wavelength, const Bin1D &alpha_bin, const Bin1D &phi_bin) const;
    IDoubleToComplexMap *mp_kz_function;
    IDoubleToPairOfComplexMap *mp_RT_function;
 
diff --git a/Core/Algorithms/inc/LayerDecoratorDWBASimulation.h b/Core/Algorithms/inc/LayerDecoratorDWBASimulation.h
index 0903775b2a9e9b9bece2ae2d7b84e80af88b4999..258003ece49899255603c3860b238866e4f24e05 100644
--- a/Core/Algorithms/inc/LayerDecoratorDWBASimulation.h
+++ b/Core/Algorithms/inc/LayerDecoratorDWBASimulation.h
@@ -43,7 +43,7 @@ private:
 
     IInterferenceFunctionStrategy *createAndInitStrategy() const;
     std::vector<IFormFactor *> createDWBAFormFactors() const;
-    void calculateCoherentIntensity(IInterferenceFunctionStrategy *p_strategy);
+    void calculateCoherentIntensity(const IInterferenceFunctionStrategy *p_strategy);
     void calculateInCoherentIntensity();
 
 };
diff --git a/Core/Algorithms/inc/OpticalFresnel.h b/Core/Algorithms/inc/OpticalFresnel.h
index b36c802c33a52f2d32a9cab195458e120592b9cd..722736854b971aace8da6b6e1ebb80be6798f5db 100644
--- a/Core/Algorithms/inc/OpticalFresnel.h
+++ b/Core/Algorithms/inc/OpticalFresnel.h
@@ -20,6 +20,7 @@
 #include "MultiLayer.h"
 
 
+//class MultiLayer;
 
 /* ************************************************************************* */
 // optical fresnel coefficients
@@ -65,7 +66,7 @@ public:
     typedef MultiLayerCoeff MultiLayerCoeff_t; // set of Fresnel coefficients for set of layers, [nlayer]
 
     //! calculate fresnel coefficients for given multi layer and kvector
-    int execute(const MultiLayer &sample, const kvector_t &k, MultiLayerCoeff_t &coeff);
+    void execute(const MultiLayer &sample, const kvector_t &k, MultiLayerCoeff_t &coeff);
 
 private:
     bool m_use_roughness;
diff --git a/Core/Algorithms/src/ChiSquaredFrequency.cpp b/Core/Algorithms/src/ChiSquaredFrequency.cpp
index 1991f387f6460378702937f31971a6d146d38339..fe2bc5fe3696f578a3b697e753766d46ace966ca 100644
--- a/Core/Algorithms/src/ChiSquaredFrequency.cpp
+++ b/Core/Algorithms/src/ChiSquaredFrequency.cpp
@@ -60,6 +60,9 @@ double ChiSquaredFrequency::calculateChiSquared()
 
 OutputData<double>* ChiSquaredFrequency::createChi2DifferenceMap() const
 {
+    assert(mp_simulation_ft != NULL);
+    assert(mp_real_ft != NULL);
+
     OutputData<double> *p_difference = mp_weights->clone();
 
     OutputData<double>::iterator it_diff = p_difference->begin();
diff --git a/Core/Algorithms/src/ChiSquaredModule.cpp b/Core/Algorithms/src/ChiSquaredModule.cpp
index ce37b15732bbc5c13de87ed99b12b4f91fcef8f5..795780b0ed76afe14f5c26e692de7059af03a87d 100644
--- a/Core/Algorithms/src/ChiSquaredModule.cpp
+++ b/Core/Algorithms/src/ChiSquaredModule.cpp
@@ -54,9 +54,9 @@ double ChiSquaredModule::calculateChiSquared()
 
 double ChiSquaredModule::getResidualValue(size_t index ) const
 {
-    assert(mp_real_data);
-    assert(mp_simulation_data);
-    assert(mp_weights);
+    assert(mp_real_data != NULL );
+    assert(mp_simulation_data != NULL);
+    assert(mp_weights != NULL);
     assert(index < mp_real_data->getAllocatedSize() );
     double value_real = (*mp_real_data)[index];
     double value_simu  = (*mp_simulation_data)[index];
diff --git a/Core/Algorithms/src/ConvolutionDetectorResolution.cpp b/Core/Algorithms/src/ConvolutionDetectorResolution.cpp
index ecaac74237405286f944caca8e2cce51423c1659..5df867dd574b4ae1cb1976494ae5249c8b2986cd 100644
--- a/Core/Algorithms/src/ConvolutionDetectorResolution.cpp
+++ b/Core/Algorithms/src/ConvolutionDetectorResolution.cpp
@@ -1,8 +1,6 @@
 #include "ConvolutionDetectorResolution.h"
 #include "Convolve.h"
-#include "Exceptions.h"
 
-#include <cmath>
 #include <iostream>
 
 
@@ -188,6 +186,7 @@ double ConvolutionDetectorResolution::getIntegratedPDF1d(double x,
     double halfstep = step/2.0;
     double xmin = x - halfstep;
     double xmax = x + halfstep;
+    assert(m_res_function_1d != NULL);
     return m_res_function_1d(xmax) - m_res_function_1d(xmin);
 }
 
diff --git a/Core/Algorithms/src/DWBADiffuseReflection.cpp b/Core/Algorithms/src/DWBADiffuseReflection.cpp
index 0b9f81af0c360eb532bd689c2feb50448fa4968e..b6e7c3ceb43aea3d5f05a31cc5d383d4b67dbaf2 100644
--- a/Core/Algorithms/src/DWBADiffuseReflection.cpp
+++ b/Core/Algorithms/src/DWBADiffuseReflection.cpp
@@ -1,5 +1,4 @@
 #include "DWBADiffuseReflection.h"
-#include "OpticalFresnel.h"
 #include "LayerRoughness.h"
 
 
diff --git a/Core/Algorithms/src/Detector.cpp b/Core/Algorithms/src/Detector.cpp
index df8d67a39bf96182c5ee66e1037e3de4e9883322..8a4e2f20f895b84a4d1f3b860b6a7bab25cc19e5 100644
--- a/Core/Algorithms/src/Detector.cpp
+++ b/Core/Algorithms/src/Detector.cpp
@@ -1,7 +1,6 @@
 #include "Detector.h"
 #include "AxisBin.h"
 #include "AxisDouble.h"
-#include "Exceptions.h"
 
 
 /* ************************************************************************* */
diff --git a/Core/Algorithms/src/Experiment.cpp b/Core/Algorithms/src/Experiment.cpp
index 2367c8a1ac34525cb0b3404356a08d889d802878..4c4e5bfd4eda3c8d9c109d40da1bf8806a4eca3b 100644
--- a/Core/Algorithms/src/Experiment.cpp
+++ b/Core/Algorithms/src/Experiment.cpp
@@ -1,7 +1,5 @@
 #include "Experiment.h"
 
-#include <typeinfo>
-
 Experiment::Experiment()
 : mp_sample(0)
 , mp_sample_builder(0)
diff --git a/Core/Algorithms/src/GISASExperiment.cpp b/Core/Algorithms/src/GISASExperiment.cpp
index 3f48cc602fa5ec0746b11bca72d935c3d2873945..312ee7dcd992fd5bce43f68433fa354de983cb04 100644
--- a/Core/Algorithms/src/GISASExperiment.cpp
+++ b/Core/Algorithms/src/GISASExperiment.cpp
@@ -22,7 +22,7 @@ GISASExperiment::GISASExperiment()
             100, 0.0*Units::degree, 2.0*Units::degree);
 }
 
-GISASExperiment::GISASExperiment(ProgramOptions *p_options)
+GISASExperiment::GISASExperiment(const ProgramOptions *p_options)
 : Experiment(p_options)
 {
     setName("GISASExperiment");
@@ -70,7 +70,7 @@ void GISASExperiment::runSimulation()
     } else {
         // if n_threads=0, take optimal number of threads from the hardware
         if(n_threads_total == 0 )  {
-            n_threads_total = boost::thread::hardware_concurrency();
+            n_threads_total = (int)boost::thread::hardware_concurrency();
             std::cout << "GISASExperiment::runSimulation() -> Info. Number of threads " << n_threads_total << " (taken from hardware concurrency)" << std::endl;
         }else {
             std::cout << "GISASExperiment::runSimulation() -> Info. Number of threads " << n_threads_total << " (hardware concurrency: " << boost::thread::hardware_concurrency() << " )"<< std::endl;
@@ -266,14 +266,14 @@ double GISASExperiment::deltaAlpha(double alpha, double zeta) const
     return std::sin(alpha)*(1.0/std::cos(zeta)-1.0);
 }
 
-double GISASExperiment::deltaPhi(double alpha, double phi, double zeta)
+double GISASExperiment::deltaPhi(double alpha, double phi, double zeta) const
 {
     double qy2 = std::sin(phi)*std::sin(phi) - std::sin(alpha)*std::sin(alpha)*std::tan(zeta)*std::tan(zeta);
     return std::sqrt(qy2) - std::sin(phi);
 }
 
 void GISASExperiment::createZetaAndProbVectors(std::vector<double>& zetas,
-        std::vector<double>& probs, size_t nbr_zetas, double zeta_sigma)
+        std::vector<double>& probs, size_t nbr_zetas, double zeta_sigma) const
 {
     double zeta_step;
     if (nbr_zetas<2) {
@@ -291,6 +291,7 @@ void GISASExperiment::createZetaAndProbVectors(std::vector<double>& zetas,
         probs.push_back(prob);
         prob_total += prob;
     }
+    assert(prob_total != 0);
     for (size_t i=0; i<nbr_zetas; ++i) {
         probs[i] /= prob_total;
     }
diff --git a/Core/Algorithms/src/IFittingDataSelector.cpp b/Core/Algorithms/src/IFittingDataSelector.cpp
index 0553e8057e68805109545179f4e4e3b5aaafda31..7284d4867b2a90ecf0cbd8f81fa745335e1562fd 100644
--- a/Core/Algorithms/src/IFittingDataSelector.cpp
+++ b/Core/Algorithms/src/IFittingDataSelector.cpp
@@ -1,5 +1,4 @@
 #include "IFittingDataSelector.h"
-#include "Exceptions.h"
 
 OutputData<double> *DefaultAllDataSelector::createWeightMap(const OutputData<double>& real_data,
         const OutputData<double>& simulated_data) const
diff --git a/Core/Algorithms/src/LayerDWBASimulation.cpp b/Core/Algorithms/src/LayerDWBASimulation.cpp
index 058b245801b01b647a4dcb4c62b733d4a0b26d85..64f6a0615070166b2fe32f496fbf3cae2f889b1b 100644
--- a/Core/Algorithms/src/LayerDWBASimulation.cpp
+++ b/Core/Algorithms/src/LayerDWBASimulation.cpp
@@ -30,8 +30,9 @@ void LayerDWBASimulation::setKzAndRTFunctions(const IDoubleToComplexMap &kz_func
     setReflectionTransmissionFunction(rt_map);
 }
 
-Bin1DCVector LayerDWBASimulation::getKfBin(double wavelength, const Bin1D& alpha_bin, const Bin1D& phi_bin)
+Bin1DCVector LayerDWBASimulation::getKfBin(double wavelength, const Bin1D& alpha_bin, const Bin1D& phi_bin) const
 {
+    assert(mp_kz_function != NULL);
     Bin1DCVector k_f_bin(wavelength, alpha_bin, phi_bin);
     k_f_bin.m_q_lower.setZ(mp_kz_function->evaluate(alpha_bin.m_lower));
     k_f_bin.m_q_upper.setZ(mp_kz_function->evaluate(alpha_bin.m_upper));
diff --git a/Core/Algorithms/src/LayerDecoratorDWBASimulation.cpp b/Core/Algorithms/src/LayerDecoratorDWBASimulation.cpp
index e6d917e636ac3efe0788d645aabaf7039d19c1c5..14e34708ecdd8fb4c591484758120e83026fc7cb 100644
--- a/Core/Algorithms/src/LayerDecoratorDWBASimulation.cpp
+++ b/Core/Algorithms/src/LayerDecoratorDWBASimulation.cpp
@@ -2,7 +2,7 @@
 #include "LayerDecorator.h"
 #include "FormFactorDWBAConstZ.h"
 #include "FormFactorDecoratorFactor.h"
-#include "Transform3D.h"
+//#include "Transform3D.h"
 #include "FormFactorDecoratorTransformation.h"
 #include "ExperimentConstants.h"
 
@@ -79,7 +79,7 @@ std::vector<IFormFactor *> LayerDecoratorDWBASimulation::createDWBAFormFactors()
     return result;
 }
 
-void LayerDecoratorDWBASimulation::calculateCoherentIntensity(IInterferenceFunctionStrategy *p_strategy)
+void LayerDecoratorDWBASimulation::calculateCoherentIntensity(const IInterferenceFunctionStrategy *p_strategy)
 {
     //std::cout << "Calculating coherent scattering..." << std::endl;
     double wavelength = getWaveLength();
diff --git a/Core/Algorithms/src/Mask.cpp b/Core/Algorithms/src/Mask.cpp
index 10be36d491fa342d1e8792a67021b519794e6d1f..0accf64709e86db6a63cca5156034d420530c59f 100644
--- a/Core/Algorithms/src/Mask.cpp
+++ b/Core/Algorithms/src/Mask.cpp
@@ -114,8 +114,8 @@ MaskCoordinates::MaskCoordinates(size_t rank, const int* dims, Mask* p_submask)
 
 MaskCoordinates::~MaskCoordinates()
 {
-    delete m_dims;
-    delete m_coordinates;
+    delete [] m_dims;
+    delete [] m_coordinates;
     if (mp_mask_function) delete mp_mask_function;
 }
 
diff --git a/Core/Algorithms/src/MultiLayerDWBASimulation.cpp b/Core/Algorithms/src/MultiLayerDWBASimulation.cpp
index 69af977bdfdc63863b9c9b4e3f6ef6cff983c3b3..4154908234e4b757c7832fb22c7a2a565580dc92 100644
--- a/Core/Algorithms/src/MultiLayerDWBASimulation.cpp
+++ b/Core/Algorithms/src/MultiLayerDWBASimulation.cpp
@@ -1,5 +1,6 @@
 #include "MultiLayerDWBASimulation.h"
 #include "OpticalFresnel.h"
+#include "MultiLayer.h"
 #include "DoubleToComplexInterpolatingFunction.h"
 #include "MultiLayerRoughnessDWBASimulation.h"
 #include "DoubleToComplexMap.h"
diff --git a/Core/Algorithms/src/OpticalFresnel.cpp b/Core/Algorithms/src/OpticalFresnel.cpp
index 8a8988b76c39edb748fec2047027e8c7b9a98403..cdbd657010b6bf2126706359c7da2ca0e19b2bd1 100644
--- a/Core/Algorithms/src/OpticalFresnel.cpp
+++ b/Core/Algorithms/src/OpticalFresnel.cpp
@@ -1,6 +1,7 @@
 #include <iostream>
 #include <algorithm>
 #include "OpticalFresnel.h"
+//#include "MultiLayer.h"
 #include "Numeric.h"
 
 
@@ -10,7 +11,7 @@ OpticalFresnel::OpticalFresnel() : m_use_roughness(false)
 }
 
 
-int OpticalFresnel::execute(const MultiLayer &sample, const kvector_t &kvec, MultiLayerCoeff_t &coeff)
+void OpticalFresnel::execute(const MultiLayer &sample, const kvector_t &kvec, MultiLayerCoeff_t &coeff)
 {
     coeff.clear();
     coeff.resize(sample.getNumberOfLayers());
@@ -35,7 +36,6 @@ int OpticalFresnel::execute(const MultiLayer &sample, const kvector_t &kvec, Mul
 
     calculateRT2(sample, coeff);
 
-    return 0;
 }
 
 void OpticalFresnel::calculateKZ(const MultiLayer &sample, const kvector_t &kvec, MultiLayerCoeff_t &coeff)
diff --git a/Core/FormFactors/inc/FormFactorCylinder.h b/Core/FormFactors/inc/FormFactorCylinder.h
index bc688242706feb442b8a1f3ed0b72f9573f19619..4103d8fb206bf5d8200cec010f2582eef144cc80 100644
--- a/Core/FormFactors/inc/FormFactorCylinder.h
+++ b/Core/FormFactors/inc/FormFactorCylinder.h
@@ -15,7 +15,7 @@
 //! @date   01.05.2012
 
 #include "IFormFactorBorn.h"
-#include "IStochasticParameter.h"
+//#include "IStochasticParameter.h"
 
 
 class FormFactorCylinder : public IFormFactorBorn
diff --git a/Core/FormFactors/inc/FormFactorDWBA.h b/Core/FormFactors/inc/FormFactorDWBA.h
index 33ba353ca397cabc4bca730e9850c3fd96acd06f..f4a36853e2998d7cdc9187a7a6af7bb48c2102f9 100644
--- a/Core/FormFactors/inc/FormFactorDWBA.h
+++ b/Core/FormFactors/inc/FormFactorDWBA.h
@@ -32,22 +32,22 @@ public:
         mp_RT = p_rt.clone();
     }
 
-
     virtual complex_t evaluate(const cvector_t &k_i, const Bin1DCVector &k_f_bin, double alpha_i, double alpha_f) const;
 
 protected:
-    //! copy constructor and assignment operator are hidden since there is a clone method
-    FormFactorDWBA(const FormFactorDWBA &);
-    FormFactorDWBA &operator=(const FormFactorDWBA &);
-
     const complexpair_t &getRT(double alpha) const;
     void calculateTerms(const cvector_t &k_i, const Bin1DCVector &k_f_bin, double alpha_i, double alpha_f) const;
 
     IDoubleToPairOfComplexMap *mp_RT;
 
     mutable complex_t m_term_S, m_term_RS, m_term_SR, m_term_RSR;
+
+private:
+    FormFactorDWBA(const FormFactorDWBA &);
+    FormFactorDWBA &operator=(const FormFactorDWBA &);
 };
 
+
 inline const complexpair_t &FormFactorDWBA::getRT(double alpha) const
 {
     return mp_RT->evaluate(alpha);
diff --git a/Core/FormFactors/inc/FormFactorDWBAConstZ.h b/Core/FormFactors/inc/FormFactorDWBAConstZ.h
index 996f1c11d389f8ee125f763555f12e14bad98e09..3cfdb65565f25b1255f01771e8882fd248b821d8 100644
--- a/Core/FormFactors/inc/FormFactorDWBAConstZ.h
+++ b/Core/FormFactors/inc/FormFactorDWBAConstZ.h
@@ -29,7 +29,6 @@ protected:
     double m_depth;
 
 private:
-    //! copy constructor and assignment operator are hidden since there is a clone method
     FormFactorDWBAConstZ(const FormFactorDWBAConstZ &);
     FormFactorDWBAConstZ &operator=(const FormFactorDWBAConstZ &);
 
@@ -39,8 +38,6 @@ private:
         return std::exp(exponent);
     }
 
-
-
 };
 
 #endif /* FORMFACTORDWBACONSTZ_H_ */
diff --git a/Core/FormFactors/inc/FormFactorDecoratorPositionFactor.h b/Core/FormFactors/inc/FormFactorDecoratorPositionFactor.h
index 0bb0d23288f751ab5d1996f8b28423735ecde565..2bbf76eb8014fa5d923522e19a2872e9158feeda 100644
--- a/Core/FormFactors/inc/FormFactorDecoratorPositionFactor.h
+++ b/Core/FormFactors/inc/FormFactorDecoratorPositionFactor.h
@@ -34,6 +34,10 @@ public:
     }
 protected:
     kvector_t m_position;
+
+private:
+    FormFactorDecoratorPositionFactor(const FormFactorDecoratorPositionFactor &);
+    FormFactorDecoratorPositionFactor &operator=(const FormFactorDecoratorPositionFactor &);
 };
 
 inline FormFactorDecoratorPositionFactor::FormFactorDecoratorPositionFactor(
diff --git a/Core/FormFactors/inc/FormFactorDecoratorRefractiveIndex.h b/Core/FormFactors/inc/FormFactorDecoratorRefractiveIndex.h
index 362d576f595f6d03a31f4391c46815f6fd2e6ffe..c51089753fb1713222095c94f32b4803997f50b4 100644
--- a/Core/FormFactors/inc/FormFactorDecoratorRefractiveIndex.h
+++ b/Core/FormFactors/inc/FormFactorDecoratorRefractiveIndex.h
@@ -26,7 +26,11 @@ public:
 
     virtual void setAmbientRefractiveIndex(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 m_refractive_index;
 };
 
diff --git a/Core/FormFactors/inc/FormFactorEllipsoid.h b/Core/FormFactors/inc/FormFactorEllipsoid.h
index 55213144dda706bc21a95929f4ef9d1406b0329f..eabe27db16cc3ac4cdb881efae52c76ff7ca67a7 100644
--- a/Core/FormFactors/inc/FormFactorEllipsoid.h
+++ b/Core/FormFactors/inc/FormFactorEllipsoid.h
@@ -45,8 +45,8 @@ protected:
     virtual void init_parameters();
 
 private:
-    //! print class
-    void print(std::ostream &ostr) const;
+    FormFactorEllipsoid(const FormFactorEllipsoid &);
+    FormFactorEllipsoid &operator=(const FormFactorEllipsoid &);
 
     double m_radius;
     double m_width;
diff --git a/Core/FormFactors/inc/FormFactorFullSphere.h b/Core/FormFactors/inc/FormFactorFullSphere.h
index e6bd0a52a918c0f134dfccc5792df4399a92e719..b4700d7fdbf476c54cf116812dd279d3494ce0ad 100644
--- a/Core/FormFactors/inc/FormFactorFullSphere.h
+++ b/Core/FormFactors/inc/FormFactorFullSphere.h
@@ -21,29 +21,28 @@ class FormFactorFullSphere : public IFormFactorBorn
 {
 public:
     FormFactorFullSphere(double radius);
-//    FormFactorFullSphere(StochasticParameter<double> *p_radius);
     ~FormFactorFullSphere();
     virtual FormFactorFullSphere *clone() const;
 
     virtual int getNumberOfStochasticParameters() const { return 1; }
 
     //! return radius of sphere
-    double getRadius() const { return m_radius; }
+    virtual double getRadius() const { return m_radius; }
 
+    //! return diameter of sphere
     virtual double getHeight() const { return 2.0*m_radius; }
 
     virtual complex_t evaluate_for_q(const cvector_t &q) const;
 
-private:
-
+protected:
     //! 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;
+private:
+    FormFactorFullSphere(const FormFactorFullSphere &);
+    FormFactorFullSphere &operator=(const FormFactorFullSphere &);
 
     double m_radius;
-//    StochasticParameter<double> *mp_radius;
 };
 
 
diff --git a/Core/FormFactors/inc/FormFactorGauss.h b/Core/FormFactors/inc/FormFactorGauss.h
index 7502f852dd6c059b68c8a9b04c53b8f5b8496cbe..6a976d5b0e6fe49feebd3e42fbef0d043eeb397c 100644
--- a/Core/FormFactors/inc/FormFactorGauss.h
+++ b/Core/FormFactors/inc/FormFactorGauss.h
@@ -30,19 +30,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:
     //! copy constructor and assignment operator are hidden since there is a clone method
     FormFactorGauss(const FormFactorGauss &);
     FormFactorGauss &operator=(const FormFactorGauss &);
 
-    //! 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;
-
-//    StochasticParameter<double> *mp_height;
-//    StochasticParameter<double> *mp_width;
     double m_height;
     double m_width;
 };
diff --git a/Core/FormFactors/inc/FormFactorLorentz.h b/Core/FormFactors/inc/FormFactorLorentz.h
index ed7cc2a2172b1656a369b008003a8850dd0ac25e..c061ee3c6a97898a8f9183f25c607db7438e7ad3 100644
--- a/Core/FormFactors/inc/FormFactorLorentz.h
+++ b/Core/FormFactors/inc/FormFactorLorentz.h
@@ -30,19 +30,14 @@ public:
 
     virtual complex_t evaluate_for_q(const cvector_t &q) const;
 
-private:
-    //! copy constructor and assignment operator are hidden since there is a clone method
-    FormFactorLorentz(const FormFactorLorentz &);
-    FormFactorLorentz &operator=(const FormFactorLorentz &);
-
+protected:
     //! 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;
+private:
+    FormFactorLorentz(const FormFactorLorentz &);
+    FormFactorLorentz &operator=(const FormFactorLorentz &);
 
-//    StochasticParameter<double> *mp_height;
-//    StochasticParameter<double> *mp_width;
     double m_height;
     double m_width;
 };
diff --git a/Core/FormFactors/inc/FormFactorParallelepiped.h b/Core/FormFactors/inc/FormFactorParallelepiped.h
index 4b5da7425e782446ffe8534c7c549fb58ed75890..c3d2b39f58dfae2b2d340ed9f761e16580a43236 100644
--- a/Core/FormFactors/inc/FormFactorParallelepiped.h
+++ b/Core/FormFactors/inc/FormFactorParallelepiped.h
@@ -37,13 +37,13 @@ public:
 
     virtual complex_t evaluate_for_q(const cvector_t &q) const;
 
-private:
-
+protected:
     //! 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;
+private:
+    FormFactorParallelepiped(const FormFactorParallelepiped &);
+    FormFactorParallelepiped &operator=(const FormFactorParallelepiped &);
 
     double m_height;
     double m_radius;
diff --git a/Core/FormFactors/inc/FormFactorPrism3.h b/Core/FormFactors/inc/FormFactorPrism3.h
index d32ecbe16f55614f12d0f3a4fccd83c9b96836f1..66a09b0f890078aa4379b956be26630bed4bd728 100644
--- a/Core/FormFactors/inc/FormFactorPrism3.h
+++ b/Core/FormFactors/inc/FormFactorPrism3.h
@@ -22,7 +22,6 @@ class FormFactorPrism3 : public IFormFactorBorn
 {
 public:
     FormFactorPrism3(double height, double half_side);
-//    FormFactorPrism3(StochasticParameter<double> *p_height, StochasticParameter<double> *p_half_side);
     ~FormFactorPrism3();
     virtual FormFactorPrism3 *clone() const;
 
@@ -32,23 +31,18 @@ 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:
     //! copy constructor and assignment operator are hidden since there is a clone method
     FormFactorPrism3(const FormFactorPrism3 &);
     FormFactorPrism3 &operator=(const FormFactorPrism3 &);
 
-    //! 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;
-
     double m_height;
-    double m_half_side;
-//    StochasticParameter<double> *mp_height;
-//    StochasticParameter<double> *mp_half_side;
-    // Cached value of square root of 3
-    double m_root3;
+    double m_half_side;    
+    double m_root3; // Cached value of square root of 3
 };
 
 
diff --git a/Core/FormFactors/inc/FormFactorPrism6.h b/Core/FormFactors/inc/FormFactorPrism6.h
index 3c6afa11bec5635a63eadbdd13bd817fadb196e6..823131ec3b4f261d4cb275dc48b6245e21a7fd24 100644
--- a/Core/FormFactors/inc/FormFactorPrism6.h
+++ b/Core/FormFactors/inc/FormFactorPrism6.h
@@ -29,27 +29,19 @@ public:
 
     virtual double getHeight() const { return m_height; }
 
-
-protected:
     virtual complex_t evaluate_for_q(const cvector_t &q) const;
 
-private:
-    //! copy constructor and assignment operator are hidden since there is a clone method
-    FormFactorPrism6(const FormFactorPrism6 &);
-    FormFactorPrism6 &operator=(const FormFactorPrism6 &);
-
+protected:    
     //! 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;
+private:
+    FormFactorPrism6(const FormFactorPrism6 &);
+    FormFactorPrism6 &operator=(const FormFactorPrism6 &);
 
     double m_height;
     double m_half_side;
-//    StochasticParameter<double> *mp_height;
-//    StochasticParameter<double> *mp_half_side;
-    // Cached value of square root of 3
-    double m_root3;
+    double m_root3; // Cached value of square root of 3
 };
 
 #endif // FORMFACTORPRISM6_H
diff --git a/Core/FormFactors/inc/FormFactorPyramid.h b/Core/FormFactors/inc/FormFactorPyramid.h
index 6bb373c723f67cf42ab56d70b9bf01b638c1828d..4b47610aa77cc5314f7b5c0988197f945cc40475 100644
--- a/Core/FormFactors/inc/FormFactorPyramid.h
+++ b/Core/FormFactors/inc/FormFactorPyramid.h
@@ -30,7 +30,7 @@ public:
     //! @param half_side half of pyramid's base
     //! @param angle in radians between base and facet
     FormFactorPyramid(double height, double half_side, double alpha);
-//    FormFactorPyramid(StochasticParameter<double> *p_height, StochasticParameter<double> *p_half_side, StochasticParameter<double> *p_alpha);
+
     ~FormFactorPyramid();
     virtual FormFactorPyramid *clone() const;
 
@@ -40,23 +40,18 @@ 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:
     //! copy constructor and assignment operator are hidden since there is a clone method
     FormFactorPyramid(const FormFactorPyramid &);
     FormFactorPyramid &operator=(const FormFactorPyramid &);
 
-    //! 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;
-
     double m_height;
     double m_half_side;
     double m_alpha;
-//    StochasticParameter<double> *mp_height;
-//    StochasticParameter<double> *mp_half_side;
-//    StochasticParameter<double> *mp_alpha;
 };
 
 
diff --git a/Core/FormFactors/inc/FormFactorSphere.h b/Core/FormFactors/inc/FormFactorSphere.h
index c834460e8da9e82690ce57d7305e607f20b9bba2..04382aeadd3cf1fffab8969e8375ce882a23986f 100644
--- a/Core/FormFactors/inc/FormFactorSphere.h
+++ b/Core/FormFactors/inc/FormFactorSphere.h
@@ -38,27 +38,18 @@ public:
 
     virtual double getHeight() const { return m_height; }
 
-protected:
     virtual complex_t evaluate_for_q(const cvector_t &q) const;
 
-private:
-    //! copy constructor and assignment operator are hidden since there is a clone method
-    FormFactorSphere(const FormFactorSphere &);
-    FormFactorSphere &operator=(const FormFactorSphere &);
-
+protected:
     //! 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;
+private:
+    FormFactorSphere(const FormFactorSphere &);
+    FormFactorSphere &operator=(const FormFactorSphere &);
 
     double m_radius;
     double m_height;
-
-
-//    StochasticParameter<double> *mp_height;
-//    StochasticParameter<double> *mp_half_side;
-//    StochasticParameter<double> *mp_alpha;
 };
 
 #endif // FORMFACTORSPHERE_H
diff --git a/Core/FormFactors/inc/FormFactorSphereGaussianRadius.h b/Core/FormFactors/inc/FormFactorSphereGaussianRadius.h
index 3790d6e0f07042be78ed678e8837c17f91cdc48c..c4126a671c63dd301d8f4b38c89676e7c1676980 100644
--- a/Core/FormFactors/inc/FormFactorSphereGaussianRadius.h
+++ b/Core/FormFactors/inc/FormFactorSphereGaussianRadius.h
@@ -33,8 +33,13 @@ public:
     virtual double getHeight() const { return p_ff_sphere->getHeight(); }
 
     virtual complex_t evaluate_for_q(const cvector_t &q) const;
+
 private:
+    FormFactorSphereGaussianRadius(const FormFactorSphereGaussianRadius &);
+    FormFactorSphereGaussianRadius &operator=(const FormFactorSphereGaussianRadius &);
+
     double calculateMeanR3() const;
+
     double m_mean; //!< This is the mean radius
     double m_sigma;
     double m_mean_r3; //!< This is the radius that gives the mean volume
@@ -87,7 +92,7 @@ inline void FormFactorSphereGaussianRadius::createDistributedFormFactors(
 {
     double sigma_range = 2.0*m_sigma;
     double step = 2.0*sigma_range/(nbr_samples-1.0);
-    double radius_start = m_mean-step*(nbr_samples/2);
+    double radius_start = m_mean-step*(nbr_samples/2); // 2 and not 2. is on purpose
     double total_prob = 0.0;
     for (size_t i=0; i<nbr_samples; ++i) {
         double radius = radius_start + (double)i*step;
@@ -96,6 +101,7 @@ inline void FormFactorSphereGaussianRadius::createDistributedFormFactors(
         probabilities.push_back(probability);
         total_prob += probability;
     }
+    assert(total_prob);
     for (size_t i=0; i<probabilities.size(); ++i) {
         probabilities[i] /= total_prob;
     }
diff --git a/Core/FormFactors/src/FormFactorEllipsoid.cpp b/Core/FormFactors/src/FormFactorEllipsoid.cpp
index ded14d377d50608443191d4c0809172fea3e29b4..f05d29cba2b9d92bde45b1b09e6f72a10265865f 100644
--- a/Core/FormFactors/src/FormFactorEllipsoid.cpp
+++ b/Core/FormFactors/src/FormFactorEllipsoid.cpp
@@ -38,11 +38,7 @@ void FormFactorEllipsoid::init_parameters()
 {
     getParameterPool()->clear();
     getParameterPool()->registerParameter("radius", &m_radius);
-    getParameterPool()->registerParameter( "width",  &m_width);
+    getParameterPool()->registerParameter("width",  &m_width);
     getParameterPool()->registerParameter("height", &m_height);
 }
-void FormFactorEllipsoid::print(std::ostream& ostr) const
-{
-    ISample::print(ostr);
-}
 
diff --git a/Core/FormFactors/src/FormFactorFullSphere.cpp b/Core/FormFactors/src/FormFactorFullSphere.cpp
index d316f90e82eebcaeb79a7f51a0d12cc855581a74..5194f499d7d7380aa6cc71eec2fc2abc058b6ae1 100644
--- a/Core/FormFactors/src/FormFactorFullSphere.cpp
+++ b/Core/FormFactors/src/FormFactorFullSphere.cpp
@@ -10,18 +10,14 @@ FormFactorFullSphere::FormFactorFullSphere(double radius)
     setName("FormFactorFullSphere");
     m_radius = radius;
     init_parameters();
-//    mp_radius = new StochasticDiracDelta<double>(radius);
 }
 
-//FormFactorFullSphere::FormFactorFullSphere(StochasticParameter<double> *p_radius)
-//    : mp_radius(p_radius)
-//{
-//}
 
 FormFactorFullSphere::~FormFactorFullSphere()
 {
 }
 
+
 /* ************************************************************************* */
 // initialize pool parameters, i.e. register some of class members for later access via parameter pool
 /* ************************************************************************* */
@@ -68,12 +64,3 @@ complex_t FormFactorFullSphere::evaluate_for_q(const cvector_t &q) const
     return radial*z_part;
 }
 
-
-/* ************************************************************************* */
-// print class
-/* ************************************************************************* */
-void FormFactorFullSphere::print(std::ostream &ostr) const
-{
-    ISample::print(ostr);
-//    ostr << " " << "(radius:"<<m_radius << ")";
-}
diff --git a/Core/FormFactors/src/FormFactorGauss.cpp b/Core/FormFactors/src/FormFactorGauss.cpp
index 7fd84ce2c8117fc80509c43f79733243f0b8667d..69bc7189df432191d6dacf63d98a6c6b5ddd59e3 100644
--- a/Core/FormFactors/src/FormFactorGauss.cpp
+++ b/Core/FormFactors/src/FormFactorGauss.cpp
@@ -22,12 +22,6 @@ FormFactorGauss::FormFactorGauss(double height, double width)
     init_parameters();
 }
 
-//FormFactorGauss::FormFactorGauss(StochasticParameter<double> *p_height, StochasticParameter<double> *p_width)
-//    : mp_height(p_height)
-//    , mp_width(p_width)
-//{
-//}
-
 FormFactorGauss::~FormFactorGauss()
 {
 }
@@ -62,11 +56,3 @@ complex_t FormFactorGauss::evaluate_for_q(const cvector_t &q) const
     return radial_part*z_part;
 }
 
-/* ************************************************************************* */
-// print class
-/* ************************************************************************* */
-void FormFactorGauss::print(std::ostream &ostr) const
-{
-    ISample::print(ostr);
-//    ostr << " (height:"<<m_height << " width:"<<m_width << ")";
-}
diff --git a/Core/FormFactors/src/FormFactorLorentz.cpp b/Core/FormFactors/src/FormFactorLorentz.cpp
index 458cf825ea5e570627429a3de2ac40017de18414..43b024a7ecc62a7cc5b0088231341ebdfa993617 100644
--- a/Core/FormFactors/src/FormFactorLorentz.cpp
+++ b/Core/FormFactors/src/FormFactorLorentz.cpp
@@ -20,20 +20,11 @@ FormFactorLorentz::FormFactorLorentz(double height, double width)
     m_height = height;
     m_width = width;
     init_parameters();
-    //    mp_height = new StochasticDiracDelta<double>(height);
-    //    mp_width = new StochasticDiracDelta<double>(width);
 }
 
-//FormFactorLorentz::FormFactorLorentz(StochasticParameter<double> *p_height, StochasticParameter<double> *p_width)
-//    : mp_height(p_height)
-//    , mp_width(p_width)
-//{
-//}
 
 FormFactorLorentz::~FormFactorLorentz()
 {
-//    delete mp_height;
-//    delete mp_width;
 }
 
 
@@ -69,11 +60,3 @@ complex_t FormFactorLorentz::evaluate_for_q(const cvector_t &q) const
     return result;
 }
 
-/* ************************************************************************* */
-// print class
-/* ************************************************************************* */
-void FormFactorLorentz::print(std::ostream &ostr) const
-{
-    ISample::print(ostr);
-//    ostr << " (height:"<<m_height << " width:"<<m_width << ")";
-}
diff --git a/Core/FormFactors/src/FormFactorParallelepiped.cpp b/Core/FormFactors/src/FormFactorParallelepiped.cpp
index b9dc14d06c6bc5441a648f8ff3196b8cda97403e..c75961071c77a915274cd6493a2950f5c66b9bf4 100644
--- a/Core/FormFactors/src/FormFactorParallelepiped.cpp
+++ b/Core/FormFactors/src/FormFactorParallelepiped.cpp
@@ -34,8 +34,3 @@ void FormFactorParallelepiped::init_parameters()
     getParameterPool()->registerParameter("height", &m_height);
     getParameterPool()->registerParameter("radius", &m_radius);
 }
-
-void FormFactorParallelepiped::print(std::ostream& ostr) const
-{
-    ISample::print(ostr);
-}
diff --git a/Core/FormFactors/src/FormFactorPrism3.cpp b/Core/FormFactors/src/FormFactorPrism3.cpp
index 6c42e3b1fed658503013a7121d17cd41164eea2c..cdc26787b9bd020dca7feb15a285b70d0c0eb5e9 100644
--- a/Core/FormFactors/src/FormFactorPrism3.cpp
+++ b/Core/FormFactors/src/FormFactorPrism3.cpp
@@ -10,22 +10,10 @@ FormFactorPrism3::FormFactorPrism3(double height, double half_side)
     m_half_side = half_side;
     m_root3 = std::sqrt(3.0);
     init_parameters();
-    //    mp_height = new StochasticDiracDelta<double>(height);
-    //    mp_half_side = new StochasticDiracDelta<double>(half_side);
 }
 
-//FormFactorPrism3::FormFactorPrism3(StochasticParameter<double>* p_height,
-//        StochasticParameter<double>* p_half_side)
-//: mp_height(p_height)
-//, mp_half_side(p_half_side)
-//{
-//    m_root3 = std::sqrt(3.0);
-//}
-
 FormFactorPrism3::~FormFactorPrism3()
 {
-//    delete mp_height;
-//    delete mp_half_side;
 }
 
 /* ************************************************************************* */
@@ -77,12 +65,3 @@ complex_t FormFactorPrism3::evaluate_for_q(const cvector_t &q) const
 }
 
 
-/* ************************************************************************* */
-// print class
-/* ************************************************************************* */
-void FormFactorPrism3::print(std::ostream &ostr) const
-{
-    ISample::print(ostr);
-//    ostr <<  " (height:"<<m_height << " half_side:"<<m_half_side << ")";
-}
-
diff --git a/Core/FormFactors/src/FormFactorPrism6.cpp b/Core/FormFactors/src/FormFactorPrism6.cpp
index 00941f000ce44cac54858352b776700ee887e8fa..ce1793f884c7045cb4b07e8088325d2f6e64199e 100644
--- a/Core/FormFactors/src/FormFactorPrism6.cpp
+++ b/Core/FormFactors/src/FormFactorPrism6.cpp
@@ -10,22 +10,11 @@ FormFactorPrism6::FormFactorPrism6(double height, double half_side)
     m_half_side = half_side;
     m_root3 = std::sqrt(3.0);
     init_parameters();
-    //    mp_height = new StochasticDiracDelta<double>(height);
-    //    mp_half_side = new StochasticDiracDelta<double>(half_side);
 }
 
-//FormFactorPrism6::FormFactorPrism6(StochasticParameter<double>* p_height,
-//        StochasticParameter<double>* p_half_side)
-//: mp_height(p_height)
-//, mp_half_side(p_half_side)
-//{
-//    m_root3 = std::sqrt(3.0);
-//}
 
 FormFactorPrism6::~FormFactorPrism6()
 {
-//    delete mp_height;
-//    delete mp_half_side;
 }
 
 
@@ -43,13 +32,10 @@ void FormFactorPrism6::init_parameters()
 FormFactorPrism6* FormFactorPrism6::clone() const
 {
       return new FormFactorPrism6(m_height, m_half_side);
-//    return new FormFactorPrism3(mp_height->clone(), mp_half_side->clone());
 }
 
 complex_t FormFactorPrism6::evaluate_for_q(const cvector_t &q) const
 {
-//    double R = mp_half_side->getCurrent();
-//    double H = mp_height->getCurrent();
     complex_t qz = q.z();
     double R = m_half_side;
     double H = m_height;
@@ -77,12 +63,3 @@ complex_t FormFactorPrism6::evaluate_for_q(const cvector_t &q) const
 }
 
 
-/* ************************************************************************* */
-// print class
-/* ************************************************************************* */
-void FormFactorPrism6::print(std::ostream &ostr) const
-{
-    ISample::print(ostr);
-//    ostr <<  " (height:"<<m_height << " half_side:"<<m_half_side << ")";
-}
-
diff --git a/Core/FormFactors/src/FormFactorPyramid.cpp b/Core/FormFactors/src/FormFactorPyramid.cpp
index 2dd690a4be45f3fd4905a96506c6ba7e96f83e7a..8acde401869ed4f10029af20407ce0480809a52d 100644
--- a/Core/FormFactors/src/FormFactorPyramid.cpp
+++ b/Core/FormFactors/src/FormFactorPyramid.cpp
@@ -14,17 +14,8 @@ FormFactorPyramid::FormFactorPyramid(double height, double half_side, double alp
     m_half_side = half_side;
     m_alpha = alpha;
     init_parameters();
-//    mp_height = new StochasticDiracDelta<double>(height);
-//    mp_half_side = new StochasticDiracDelta<double>(half_side);
-//    mp_alpha = new StochasticDiracDelta<double>(alpha);
 }
 
-//FormFactorPyramid::FormFactorPyramid(StochasticParameter<double> *p_height, StochasticParameter<double> *p_half_side, StochasticParameter<double> *p_alpha)
-//    : mp_height(p_height)
-//    , mp_half_side(p_half_side)
-//    , mp_alpha(p_alpha)
-//{
-//}
 
 FormFactorPyramid::~FormFactorPyramid()
 {
@@ -33,6 +24,7 @@ FormFactorPyramid::~FormFactorPyramid()
 //    delete mp_alpha;
 }
 
+
 /* ************************************************************************* */
 // initialize pool parameters, i.e. register some of class members for later access via parameter pool
 /* ************************************************************************* */
@@ -106,13 +98,3 @@ complex_t FormFactorPyramid::evaluate_for_q(const cvector_t &q) const
     return F;
 }
 
-
-/* ************************************************************************* */
-// print class
-/* ************************************************************************* */
-void FormFactorPyramid::print(std::ostream &ostr) const
-{
-    ISample::print(ostr);
-//    ostr << " (height:"<< m_height << " half_side:"<<m_half_side << " " << "alpha: " << m_alpha << ")";
-}
-
diff --git a/Core/FormFactors/src/FormFactorSphere.cpp b/Core/FormFactors/src/FormFactorSphere.cpp
index bc254bb2d7cac6367b4eb234c5d2209daab6a6c0..e540c6797d6f84d74fc55a15c9f8c164d094ea75 100644
--- a/Core/FormFactors/src/FormFactorSphere.cpp
+++ b/Core/FormFactors/src/FormFactorSphere.cpp
@@ -104,16 +104,6 @@ complex_t FormFactorSphere::evaluate_for_q(const cvector_t &q) const
 }
 
 
-/* ************************************************************************* */
-// print class
-/* ************************************************************************* */
-void FormFactorSphere::print(std::ostream &ostr) const
-{
-    ISample::print(ostr);
-//    ostr << " " << "(radius:"<<m_radius << ")";
-}
-
-
 //for (zk=0;zk<=2;zk+0.01) {
 //
 //    k[zk]=zk
diff --git a/Core/Tools/inc/OutputData.h b/Core/Tools/inc/OutputData.h
index 26a01388de5f40ca3193c4b2d591a1d215a6d321..8e2bad78ec7f11c37775558bf2b279daee8e3b19 100644
--- a/Core/Tools/inc/OutputData.h
+++ b/Core/Tools/inc/OutputData.h
@@ -21,7 +21,7 @@
 #include "OutputDataIterator.h"
 #include "SafePointerVector.h"
 
-#include <string>
+//#include <string>
 #include <sstream>
 
 //- -------------------------------------------------------------------