diff --git a/Core/Aggregate/DecouplingApproximationStrategy.h b/Core/Aggregate/DecouplingApproximationStrategy.h
index 7ceb961ec82716b067607140f1183def2f0f6c5d..93675ad3c3ab3e66a497fd22616ebd0cfacdb026 100644
--- a/Core/Aggregate/DecouplingApproximationStrategy.h
+++ b/Core/Aggregate/DecouplingApproximationStrategy.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Aggregate/DecouplingApproximationStrategy.h
-//! @brief     Declares class DecouplingApproximationStrategy.
+//! @brief     Defines class DecouplingApproximationStrategy.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef DECOUPLINGAPPROXIMATIONSTRATEGY_H
 #define DECOUPLINGAPPROXIMATIONSTRATEGY_H
 
-#include "IInterferenceFunctionStrategy.h" // inheriting from
+#include "IInterferenceFunctionStrategy.h"
 
 class SimulationElement;
 
diff --git a/Core/Aggregate/FTDecayFunctions.cpp b/Core/Aggregate/FTDecayFunctions.cpp
index c25edc55d1142b55dc9ed5eb3287a2719fd0e2a2..84a15ada08b4e396e4ac3507cd9e659e5c53c08c 100644
--- a/Core/Aggregate/FTDecayFunctions.cpp
+++ b/Core/Aggregate/FTDecayFunctions.cpp
@@ -17,7 +17,7 @@
 #include "BornAgainNamespace.h"
 #include "MathFunctions.h"
 #include "ParameterPool.h"
-#include "Units.h"
+#include "Pi.h"
 
 //===============1D======================
 
@@ -55,7 +55,7 @@ FTDecayFunction1DGauss::FTDecayFunction1DGauss(double omega)
 double FTDecayFunction1DGauss::evaluate(double q) const
 {
     double sum_sq = q*q*m_omega*m_omega;
-    return m_omega*std::sqrt(Units::PI2)*std::exp(-sum_sq/2.0);
+    return m_omega*std::sqrt(Pi::PI2)*std::exp(-sum_sq/2.0);
 }
 
 FTDecayFunction1DTriangle::FTDecayFunction1DTriangle(double omega)
@@ -82,7 +82,7 @@ FTDecayFunction1DVoigt::FTDecayFunction1DVoigt(double omega, double eta)
 double FTDecayFunction1DVoigt::evaluate(double q) const
 {
     double sum_sq = q*q*m_omega*m_omega;
-    return m_eta*m_omega*std::sqrt(Units::PI2)*std::exp(-sum_sq/2.0)
+    return m_eta*m_omega*std::sqrt(Pi::PI2)*std::exp(-sum_sq/2.0)
             + (1.0 - m_eta)*m_omega*2.0/(1.0 + sum_sq);
 }
 
@@ -115,11 +115,11 @@ FTDecayFunction1DCosine::FTDecayFunction1DCosine(double omega)
 double FTDecayFunction1DCosine::evaluate(double q) const
 {
     double qw = std::abs(q*m_omega);
-    if (std::abs(qw/Units::PI-1.0) < Numeric::double_epsilon) {
+    if (std::abs(qw/Pi::PI-1.0) < Numeric::double_epsilon) {
         return m_omega/2.0;
     }
     else {
-        return m_omega*MathFunctions::Sinc(qw)/(1.0-qw*qw/Units::PI/Units::PI);
+        return m_omega*MathFunctions::Sinc(qw)/(1.0-qw*qw/Pi::PI/Pi::PI);
     }
 }
 */
@@ -137,7 +137,7 @@ IFTDecayFunction2D::IFTDecayFunction2D(
 void IFTDecayFunction2D::transformToStarBasis(double qX, double qY, double alpha,
                                               double a, double b, double &qa, double &qb) const
 {
-    double prefactor = 1.0/Units::PI2; // divide by sin(m_delta)
+    double prefactor = 1.0/Pi::PI2; // divide by sin(m_delta)
                                      // for unnormalized X*,Y* basis
     qa = a*prefactor*( std::sin(m_gamma+m_delta)*qX - std::sin(m_gamma)*qY );
     qb = b*prefactor*( -std::sin(alpha-m_gamma-m_delta)*qX + std::sin(alpha-m_gamma)*qY );
@@ -167,7 +167,7 @@ FTDecayFunction2DCauchy::FTDecayFunction2DCauchy(
 double FTDecayFunction2DCauchy::evaluate(double qx, double qy) const
 {
     double sum_sq = qx*qx*m_omega_x*m_omega_x + qy*qy*m_omega_y*m_omega_y;
-    return Units::PI2*m_omega_x*m_omega_y*std::pow(1.0 + sum_sq, -1.5);
+    return Pi::PI2*m_omega_x*m_omega_y*std::pow(1.0 + sum_sq, -1.5);
 }
 
 FTDecayFunction2DGauss::FTDecayFunction2DGauss(
@@ -181,7 +181,7 @@ FTDecayFunction2DGauss::FTDecayFunction2DGauss(
 double FTDecayFunction2DGauss::evaluate(double qx, double qy) const
 {
     double sum_sq = qx*qx*m_omega_x*m_omega_x + qy*qy*m_omega_y*m_omega_y;
-    return Units::PI2*m_omega_x*m_omega_y*std::exp(-sum_sq/2.0);
+    return Pi::PI2*m_omega_x*m_omega_y*std::exp(-sum_sq/2.0);
 }
 
 FTDecayFunction2DVoigt::FTDecayFunction2DVoigt(
@@ -195,7 +195,7 @@ FTDecayFunction2DVoigt::FTDecayFunction2DVoigt(
 double FTDecayFunction2DVoigt::evaluate(double qx, double qy) const
 {
     double sum_sq = qx*qx*m_omega_x*m_omega_x + qy*qy*m_omega_y*m_omega_y;
-    return Units::PI2*m_omega_x*m_omega_y*(m_eta*std::exp(-sum_sq/2.0)
+    return Pi::PI2*m_omega_x*m_omega_y*(m_eta*std::exp(-sum_sq/2.0)
                                            + (1.0-m_eta)*std::pow(1.0 + sum_sq, -1.5));
 }
 
diff --git a/Core/Aggregate/FTDecayFunctions.h b/Core/Aggregate/FTDecayFunctions.h
index 4828db8d6337a8aee22fc36a3a19bab1497f4b4a..954b1918858fa6be8bb53df6f5e254442c6559a9 100644
--- a/Core/Aggregate/FTDecayFunctions.h
+++ b/Core/Aggregate/FTDecayFunctions.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Aggregate/FTDecayFunctions.h
-//! @brief     Declares classes IFTDecayFunction1D, IFTDecayFunction2D,
+//! @brief     Defines classes IFTDecayFunction1D, IFTDecayFunction2D,
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,8 +16,8 @@
 #ifndef FTDECAYFUNCTIONS_H
 #define FTDECAYFUNCTIONS_H
 
-#include "IParameterized.h" // inheriting from
-#include "Units.h"
+#include "IParameterized.h"
+#include "Pi.h"
 
 //! @class IFTDecayFunction1D
 //! @ingroup algorithms_internal
@@ -160,7 +160,7 @@ class BA_CORE_API_ IFTDecayFunction2D : public IParameterized
 {
 public:
     IFTDecayFunction2D(double decay_length_x, double decay_length_y,
-                       double gamma=0, double delta=Units::PID2);
+                       double gamma=0, double delta=Pi::PID2);
     virtual ~IFTDecayFunction2D() {}
 
     virtual IFTDecayFunction2D* clone() const=0;
@@ -209,7 +209,7 @@ class BA_CORE_API_ FTDecayFunction2DCauchy : public IFTDecayFunction2D
 {
 public:
     FTDecayFunction2DCauchy(double decay_length_x, double decay_length_y,
-                            double gamma=0, double delta=Units::PID2);
+                            double gamma=0, double delta=Pi::PID2);
 
     virtual ~FTDecayFunction2DCauchy() {}
 
@@ -229,7 +229,7 @@ class BA_CORE_API_ FTDecayFunction2DGauss : public IFTDecayFunction2D
 {
 public:
     FTDecayFunction2DGauss(double decay_length_x, double decay_length_y,
-                           double gamma=0, double delta=Units::PID2);
+                           double gamma=0, double delta=Pi::PID2);
 
     virtual ~FTDecayFunction2DGauss() {}
 
@@ -248,7 +248,7 @@ class BA_CORE_API_ FTDecayFunction2DVoigt : public IFTDecayFunction2D
 {
 public:
     FTDecayFunction2DVoigt(double decay_length_x, double decay_length_y, double eta,
-                           double gamma=0, double delta=Units::PID2);
+                           double gamma=0, double delta=Pi::PID2);
 
     virtual ~FTDecayFunction2DVoigt() {}
 
diff --git a/Core/Aggregate/FTDistributions1D.cpp b/Core/Aggregate/FTDistributions1D.cpp
index 7c0532919b1de456bec57eeb88316a22ebeb934c..e6929787a19e1920575055fc4a706dc93b13c8c0 100644
--- a/Core/Aggregate/FTDistributions1D.cpp
+++ b/Core/Aggregate/FTDistributions1D.cpp
@@ -19,7 +19,7 @@
 #include "MathFunctions.h"
 #include "Numeric.h"
 #include "ParameterPool.h"
-#include "Units.h"
+#include "Pi.h"
 
 void IFTDistribution1D::print(std::ostream& ostr) const
 {
@@ -123,11 +123,11 @@ FTDistribution1DCosine *FTDistribution1DCosine::clone() const
 double FTDistribution1DCosine::evaluate(double q) const
 {
     double qw = std::abs(q*m_omega);
-    if (std::abs(qw/Units::PI-1.0) < Numeric::double_epsilon) {
+    if (std::abs(qw/Pi::PI-1.0) < Numeric::double_epsilon) {
         return 0.5;
     }
     else {
-        return MathFunctions::sinc(qw)/(1.0-qw*qw/Units::PI/Units::PI);
+        return MathFunctions::sinc(qw)/(1.0-qw*qw/Pi::PI/Pi::PI);
     }
 }
 
diff --git a/Core/Aggregate/FTDistributions1D.h b/Core/Aggregate/FTDistributions1D.h
index 00b7fec38e39a83047d6e17c87d3532196578715..333eab3cedacc621a207bba4142023771a06be1e 100644
--- a/Core/Aggregate/FTDistributions1D.h
+++ b/Core/Aggregate/FTDistributions1D.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Aggregate/FTDistributions1D.h
-//! @brief     Declares interface class IFTDistribution1D, and children thereof
+//! @brief     Defines interface class IFTDistribution1D, and children thereof
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef FTDISTRIBUTIONS1D_H
 #define FTDISTRIBUTIONS1D_H
 
-#include "IParameterized.h" // inheriting from
+#include "IParameterized.h"
 
 // ************************************************************************** //
 //! @class IFTDistribution1D
diff --git a/Core/Aggregate/FTDistributions2D.h b/Core/Aggregate/FTDistributions2D.h
index 02a6cbd250849c3ae04550d5bb30d06ce0f6bfda..40e809af9b1af493c9b8a4be8cf3cb549793e7c4 100644
--- a/Core/Aggregate/FTDistributions2D.h
+++ b/Core/Aggregate/FTDistributions2D.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Aggregate/FTDistributions2D.h
-//! @brief     Declares interface class IFTDistribution2D, and children thereof.
+//! @brief     Defines interface class IFTDistribution2D, and children thereof.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,8 +16,8 @@
 #ifndef FTDISTRIBUTIONS2D_H
 #define FTDISTRIBUTIONS2D_H
 
-#include "IParameterized.h" // inheriting from
-#include "Units.h"
+#include "IParameterized.h"
+#include "Pi.h"
 
 // ************************************************************************** //
 //! @class IFTDistribution2D
@@ -29,7 +29,7 @@ class BA_CORE_API_ IFTDistribution2D : public IParameterized
 {
 public:
     IFTDistribution2D(double coherence_length_x, double coherence_length_y,
-                      double gamma=0, double delta=Units::PID2);
+                      double gamma=0, double delta=Pi::PID2);
     virtual ~IFTDistribution2D() {}
 
     virtual IFTDistribution2D* clone() const=0;
@@ -78,7 +78,7 @@ class BA_CORE_API_ FTDistribution2DCauchy : public IFTDistribution2D
 {
 public:
     FTDistribution2DCauchy(double coherence_length_x, double coherence_length_y,
-                           double gamma=0, double delta=Units::PID2);
+                           double gamma=0, double delta=Pi::PID2);
 
     virtual ~FTDistribution2DCauchy() {}
 
@@ -101,7 +101,7 @@ class BA_CORE_API_ FTDistribution2DGauss : public IFTDistribution2D
 {
 public:
     FTDistribution2DGauss(double coherence_length_x, double coherence_length_y,
-                          double gamma=0, double delta=Units::PID2);
+                          double gamma=0, double delta=Pi::PID2);
 
     virtual ~FTDistribution2DGauss() {}
 
@@ -124,7 +124,7 @@ class BA_CORE_API_ FTDistribution2DGate : public IFTDistribution2D
 {
 public:
     FTDistribution2DGate(double coherence_length_x, double coherence_length_y,
-                         double gamma=0, double delta=Units::PID2);
+                         double gamma=0, double delta=Pi::PID2);
 
     virtual ~FTDistribution2DGate() {}
 
@@ -147,7 +147,7 @@ class BA_CORE_API_ FTDistribution2DCone : public IFTDistribution2D
 {
 public:
     FTDistribution2DCone(double coherence_length_x, double coherence_length_y,
-                         double gamma=0, double delta=Units::PID2);
+                         double gamma=0, double delta=Pi::PID2);
 
     virtual ~FTDistribution2DCone() {}
 
@@ -174,7 +174,7 @@ class BA_CORE_API_ FTDistribution2DVoigt : public IFTDistribution2D
 {
 public:
     FTDistribution2DVoigt(double coherence_length_x, double coherence_length_y,
-                          double eta, double gamma=0, double delta=Units::PID2);
+                          double eta, double gamma=0, double delta=Pi::PID2);
     virtual ~FTDistribution2DVoigt() {}
 
     FTDistribution2DVoigt* clone() const final {
diff --git a/Core/Aggregate/IInterferenceFunction.h b/Core/Aggregate/IInterferenceFunction.h
index af665878d6caa7cccb8b867c71087b7c4db05260..ec9c5ea22501f0e8ad4b5775f8905dfbc049b117 100644
--- a/Core/Aggregate/IInterferenceFunction.h
+++ b/Core/Aggregate/IInterferenceFunction.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Aggregate/IInterferenceFunction.h
-//! @brief     Declares interface class IInterferenceFunction.
+//! @brief     Defines interface class IInterferenceFunction.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef IINTERFERENCEFUNCTION_H
 #define IINTERFERENCEFUNCTION_H
 
-#include "ISample.h" // inheriting from
+#include "ISample.h"
 #include "Vectors3D.h"
 
 class ISampleVisitor;
diff --git a/Core/Aggregate/IInterferenceFunctionStrategy.cpp b/Core/Aggregate/IInterferenceFunctionStrategy.cpp
index 9bdd524ecbcf79f71e250e52a9bbe411d4bfa0ee..5df4a2049e5e63c2571f7501536df5d0be940933 100644
--- a/Core/Aggregate/IInterferenceFunctionStrategy.cpp
+++ b/Core/Aggregate/IInterferenceFunctionStrategy.cpp
@@ -22,7 +22,7 @@
 #include "LayerSpecularInfo.h"
 #include "ScalarRTCoefficients.h"
 #include "SimulationElement.h"
-#include "Units.h"
+#include "Pi.h"
 #include "WavevectorInfo.h"
 
 IInterferenceFunctionStrategy::IInterferenceFunctionStrategy(
@@ -76,7 +76,7 @@ void IInterferenceFunctionStrategy::calculateFormFactorList(
     clearFormFactorLists();
 
     double wavelength = sim_element.getWavelength();
-    double wavevector_scattering_factor = Units::PI/wavelength/wavelength;
+    double wavevector_scattering_factor = Pi::PI/wavelength/wavelength;
     double alpha_i = sim_element.getAlphaI();
     double phi_i = sim_element.getPhiI();
     cvector_t k_i = Geometry::vecOfLambdaAlphaPhi(wavelength, alpha_i, phi_i).complex();
@@ -99,7 +99,7 @@ void IInterferenceFunctionStrategy::calculateFormFactorLists(
     clearFormFactorLists();
 
     double wavelength = sim_element.getWavelength();
-    double wavevector_scattering_factor = Units::PI/wavelength/wavelength;
+    double wavevector_scattering_factor = Pi::PI/wavelength/wavelength;
     double alpha_i = sim_element.getAlphaI();
     double phi_i = sim_element.getPhiI();
     cvector_t k_i = Geometry::vecOfLambdaAlphaPhi(wavelength, alpha_i, phi_i).complex();
diff --git a/Core/Aggregate/IInterferenceFunctionStrategy.h b/Core/Aggregate/IInterferenceFunctionStrategy.h
index 9798ed5f64cd34c25112046e7d96af471127f5af..00f0f3d651dbd3df582faaf165e7bef48ec8e268 100644
--- a/Core/Aggregate/IInterferenceFunctionStrategy.h
+++ b/Core/Aggregate/IInterferenceFunctionStrategy.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Aggregate/IInterferenceFunctionStrategy.h
-//! @brief     Declares class IInterferenceFunctionStrategy.
+//! @brief     Defines class IInterferenceFunctionStrategy.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Aggregate/ILayout.h b/Core/Aggregate/ILayout.h
index 403cc4d3487d61993d27135bc10fe8a24d9a7151..b5e7fb955f7032ffa4282fc9e4f53125464b6316 100644
--- a/Core/Aggregate/ILayout.h
+++ b/Core/Aggregate/ILayout.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Aggregate/ILayout.h
-//! @brief     Declares interface class ILayout.
+//! @brief     Defines interface class ILayout.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef ILAYOUT_H
 #define ILAYOUT_H
 
-#include "ICompositeSample.h" // inheriting from
+#include "ICompositeSample.h"
 #include "SafePointerVector.h"
 
 class IAbstractParticle;
diff --git a/Core/Aggregate/InterferenceFunction1DLattice.cpp b/Core/Aggregate/InterferenceFunction1DLattice.cpp
index 8ff196b8efa57a09501116073b384b7746527d6e..e57adace42289fec52585a7ca185f125715dd6e0 100644
--- a/Core/Aggregate/InterferenceFunction1DLattice.cpp
+++ b/Core/Aggregate/InterferenceFunction1DLattice.cpp
@@ -18,7 +18,7 @@
 #include "Exceptions.h"
 #include "FTDecayFunctions.h"
 #include "ISampleVisitor.h"
-#include "Units.h"
+#include "Pi.h"
 
 using namespace BornAgain;
 
@@ -58,7 +58,7 @@ void InterferenceFunction1DLattice::setDecayFunction(const IFTDecayFunction1D& p
         delete mp_pdf;
     mp_pdf = pdf.clone();
     double omega = mp_pdf->getOmega();
-    double qa_max = (m_lattice_params.m_length / Units::PI2) * nmax / omega;
+    double qa_max = (m_lattice_params.m_length / Pi::PI2) * nmax / omega;
     m_na = (int)(std::abs(qa_max) + 0.5);
 }
 
@@ -73,7 +73,7 @@ double InterferenceFunction1DLattice::evaluate(const kvector_t q) const
     double qx_frac;
     double xi = m_lattice_params.m_xi;
     double a = m_lattice_params.m_length;
-    double a_rec = Units::PI2 / a;
+    double a_rec = Pi::PI2 / a;
 
     // rotate the q vector to xi angle
     // so that qx_prime is along the a axis of lattice
diff --git a/Core/Aggregate/InterferenceFunction1DLattice.h b/Core/Aggregate/InterferenceFunction1DLattice.h
index fa4478383d467c1341a5e13d55be9324341294f1..04daf5ae22b26b8494b460a0451145a7fffbf8a4 100644
--- a/Core/Aggregate/InterferenceFunction1DLattice.h
+++ b/Core/Aggregate/InterferenceFunction1DLattice.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Aggregate/InterferenceFunction1DLattice.h
-//! @brief     Declares class InterferenceFunction1DLattice.
+//! @brief     Defines class InterferenceFunction1DLattice.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef INTERFERENCEFUNCTION1DLATTICE_H
 #define INTERFERENCEFUNCTION1DLATTICE_H
 
-#include "IInterferenceFunction.h" // inheriting from
+#include "IInterferenceFunction.h"
 #include "Lattice1DParameters.h"
 
 class ISampleVisitor;
diff --git a/Core/Aggregate/InterferenceFunction2DLattice.cpp b/Core/Aggregate/InterferenceFunction2DLattice.cpp
index e7ef419ac99857b0358fa6ae76e72b6496321db7..e1cae22c8bfdc5ddb11127f2c87e313fd7b1057a 100644
--- a/Core/Aggregate/InterferenceFunction2DLattice.cpp
+++ b/Core/Aggregate/InterferenceFunction2DLattice.cpp
@@ -18,7 +18,7 @@
 #include "Exceptions.h"
 #include "Macros.h"
 #include "ISampleVisitor.h"
-#include "Units.h"
+#include "Pi.h"
 
 GCC_DIAG_OFF(unused-parameter)
 #include <boost/math/special_functions/round.hpp>
@@ -63,7 +63,7 @@ InterferenceFunction2DLattice* InterferenceFunction2DLattice::createSquare(doubl
     Lattice2DParameters lattice_params;
     lattice_params.m_length_1 = lattice_length;
     lattice_params.m_length_2 = lattice_length;
-    lattice_params.m_angle = Units::PI / 2.0;
+    lattice_params.m_angle = Pi::PI / 2.0;
     lattice_params.m_xi = xi;
     return new InterferenceFunction2DLattice(lattice_params);
 }
@@ -74,7 +74,7 @@ InterferenceFunction2DLattice* InterferenceFunction2DLattice::createHexagonal(do
     Lattice2DParameters lattice_params;
     lattice_params.m_length_1 = lattice_length;
     lattice_params.m_length_2 = lattice_length;
-    lattice_params.m_angle = 2.0 * Units::PI / 3.0;
+    lattice_params.m_angle = 2.0 * Pi::PI / 3.0;
     lattice_params.m_xi = xi;
     return new InterferenceFunction2DLattice(lattice_params);
 }
@@ -171,9 +171,9 @@ void InterferenceFunction2DLattice::calculateReciprocalVectorFraction(double qx,
     double b = m_lattice_params.m_length_2;
     double xi = m_lattice_params.m_xi;
     double xialpha = xi + m_lattice_params.m_angle;
-    int qa_int = boost::math::iround(a * (qx * std::cos(xi) + qy * std::sin(xi)) / Units::PI2);
+    int qa_int = boost::math::iround(a * (qx * std::cos(xi) + qy * std::sin(xi)) / Pi::PI2);
     int qb_int
-        = boost::math::iround(b * (qx * std::cos(xialpha) + qy * std::sin(xialpha)) / Units::PI2);
+        = boost::math::iround(b * (qx * std::cos(xialpha) + qy * std::sin(xialpha)) / Pi::PI2);
     qx_frac = qx - qa_int * m_asx - qb_int * m_bsx;
     qy_frac = qy - qa_int * m_asy - qb_int * m_bsy;
 }
@@ -203,8 +203,8 @@ void InterferenceFunction2DLattice::initialize_rec_vectors()
             "initialize_rec_vectors() -> Error! Zero parameters"
             " m_lattice_params.m_length1 or m_lattice_params.m_length_2");
     double sinalpha = std::sin(m_lattice_params.m_angle);
-    double ainv = Units::PI2 / m_lattice_params.m_length_1 / sinalpha;
-    double binv = Units::PI2 / m_lattice_params.m_length_2 / sinalpha;
+    double ainv = Pi::PI2 / m_lattice_params.m_length_1 / sinalpha;
+    double binv = Pi::PI2 / m_lattice_params.m_length_2 / sinalpha;
     double xi = m_lattice_params.m_xi;
     double xialpha = xi + m_lattice_params.m_angle;
     m_asx = +ainv * std::sin(xialpha);
diff --git a/Core/Aggregate/InterferenceFunction2DLattice.h b/Core/Aggregate/InterferenceFunction2DLattice.h
index 5d90f5cadcc3b39ecb138b5ef5bd399a235562e3..bf2ab537a865d66c048ff88e08aa947e447a02fb 100644
--- a/Core/Aggregate/InterferenceFunction2DLattice.h
+++ b/Core/Aggregate/InterferenceFunction2DLattice.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Aggregate/InterferenceFunction2DLattice.h
-//! @brief     Declares class InterferenceFunction2DLattice.
+//! @brief     Defines class InterferenceFunction2DLattice.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef INTERFERENCEFUNCTION2DLATTICE_H
 #define INTERFERENCEFUNCTION2DLATTICE_H
 
-#include "IInterferenceFunction.h" // inheriting from
+#include "IInterferenceFunction.h"
 #include "FTDecayFunctions.h"
 #include "Lattice2DParameters.h"
 
diff --git a/Core/Aggregate/InterferenceFunction2DParaCrystal.cpp b/Core/Aggregate/InterferenceFunction2DParaCrystal.cpp
index b38ced0f7aac70019d63e4d70f2e7d18a6e0c192..db3f25c7f8f1abcc1129e40603e409efb2959410 100644
--- a/Core/Aggregate/InterferenceFunction2DParaCrystal.cpp
+++ b/Core/Aggregate/InterferenceFunction2DParaCrystal.cpp
@@ -20,7 +20,7 @@
 #include "IntegratorReal.h"
 #include "Numeric.h"
 #include "ParameterPool.h"
-#include "Units.h"
+#include "Pi.h"
 #include <limits>
 
 using namespace BornAgain;
@@ -97,7 +97,7 @@ double InterferenceFunction2DParaCrystal::evaluate(const kvector_t q) const
     m_qy = q.y();
     if (!m_integrate_xi)
         return interferenceForXi(m_lattice_params.m_xi);
-    return mP_integrator->integrate(0.0, Units::PI2)/Units::PI2;
+    return mP_integrator->integrate(0.0, Pi::PI2)/Pi::PI2;
 }
 
 std::string InterferenceFunction2DParaCrystal::addParametersToExternalPool(
@@ -128,7 +128,7 @@ InterferenceFunction2DParaCrystal* InterferenceFunction2DParaCrystal::createSqua
 {
     InterferenceFunction2DParaCrystal* p_new =
             new InterferenceFunction2DParaCrystal(peak_distance, peak_distance,
-                    Units::PID2, 0.0, damping_length);
+                    Pi::PID2, 0.0, damping_length);
     p_new->setDomainSizes(domain_size_1, domain_size_2);
     p_new->setIntegrationOverXi(true);
     return p_new;
@@ -138,7 +138,7 @@ InterferenceFunction2DParaCrystal* InterferenceFunction2DParaCrystal::createHexa
     double peak_distance, double damping_length, double domain_size_1, double domain_size_2)
 {
     auto p_new = new InterferenceFunction2DParaCrystal(
-        peak_distance, peak_distance, 2.0*Units::PI/3.0, 0.0, damping_length);
+        peak_distance, peak_distance, 2.0*Pi::PI/3.0, 0.0, damping_length);
     p_new->setDomainSizes(domain_size_1, domain_size_2);
     p_new->setIntegrationOverXi(true);
     return p_new;
diff --git a/Core/Aggregate/InterferenceFunction2DParaCrystal.h b/Core/Aggregate/InterferenceFunction2DParaCrystal.h
index aa0a1b9b584b362cc71494dbcdeecb4dded14d9b..e7e10e079d2aa463e09279fbe2a6a54041ba5a30 100644
--- a/Core/Aggregate/InterferenceFunction2DParaCrystal.h
+++ b/Core/Aggregate/InterferenceFunction2DParaCrystal.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Aggregate/InterferenceFunction2DParaCrystal.h
-//! @brief     Declares class InterferenceFunction2DParaCrystal.
+//! @brief     Defines class InterferenceFunction2DParaCrystal.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef INTERFERENCEFUNCTION2DPARACRYSTAL_H
 #define INTERFERENCEFUNCTION2DPARACRYSTAL_H
 
-#include "IInterferenceFunction.h" // inheriting from
+#include "IInterferenceFunction.h"
 #include "Complex.h"
 #include "FTDistributions2D.h"
 #include "Lattice2DParameters.h"
diff --git a/Core/Aggregate/InterferenceFunctionNone.h b/Core/Aggregate/InterferenceFunctionNone.h
index dfc1931738ab1144f3bc9bf84a718449c9cf95c7..097409aab1adc629669193931084d3bda8c97fab 100644
--- a/Core/Aggregate/InterferenceFunctionNone.h
+++ b/Core/Aggregate/InterferenceFunctionNone.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Aggregate/InterferenceFunctionNone.h
-//! @brief     Declares class InterferenceFunctionNone.
+//! @brief     Defines class InterferenceFunctionNone.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef INTERFERENCEFUNCTIONNONE_H
 #define INTERFERENCEFUNCTIONNONE_H
 
-#include "IInterferenceFunction.h" // inheriting from
+#include "IInterferenceFunction.h"
 
 //! @class InterferenceFunctionNone
 //! @ingroup interference
diff --git a/Core/Aggregate/InterferenceFunctionRadialParaCrystal.h b/Core/Aggregate/InterferenceFunctionRadialParaCrystal.h
index 1edbaeb6d88f646870d84c065fd0be3608414d9e..bfc9e9fb4d4beeca5dda7100a06d9000971d573f 100644
--- a/Core/Aggregate/InterferenceFunctionRadialParaCrystal.h
+++ b/Core/Aggregate/InterferenceFunctionRadialParaCrystal.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Aggregate/InterferenceFunctionRadialParaCrystal.h
-//! @brief     Declares class InterferenceFunctionRadialParaCrystal.
+//! @brief     Defines class InterferenceFunctionRadialParaCrystal.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef INTERFERENCEFUNCTIONRADIALPARACRYSTAL_H
 #define INTERFERENCEFUNCTIONRADIALPARACRYSTAL_H
 
-#include "IInterferenceFunction.h" // inheriting from
+#include "IInterferenceFunction.h"
 #include "Complex.h"
 #include "FTDistributions1D.h"
 #include <memory>
diff --git a/Core/Aggregate/ParticleLayout.h b/Core/Aggregate/ParticleLayout.h
index a70f10fb13072841237ab67798237286a01c23a6..a0ea9bb9e86d04812f043f64f3621ab525a325b4 100644
--- a/Core/Aggregate/ParticleLayout.h
+++ b/Core/Aggregate/ParticleLayout.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Aggregate/ParticleLayout.h
-//! @brief     Declares class ParticleLayout.
+//! @brief     Defines class ParticleLayout.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef PARTICLELAYOUT_H
 #define PARTICLELAYOUT_H
 
-#include "ILayout.h" // inheriting from
+#include "ILayout.h"
 #include "Vectors3D.h"
 #include <memory>
 
diff --git a/Core/Aggregate/SizeSpacingCorrelationApproximationStrategy.h b/Core/Aggregate/SizeSpacingCorrelationApproximationStrategy.h
index f655ffa5b47b7815ac793de6809bddd63dbf0f96..adf5f9302b75d38598c3cfade3ec6cf579b08903 100644
--- a/Core/Aggregate/SizeSpacingCorrelationApproximationStrategy.h
+++ b/Core/Aggregate/SizeSpacingCorrelationApproximationStrategy.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Aggregate/SizeSpacingCorrelationApproximationStrategy.h
-//! @brief     Declares class SizeSpacingCorrelationApproximationStrategy.
+//! @brief     Defines class SizeSpacingCorrelationApproximationStrategy.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef SIZESPACINGCORRELATIONAPPROXIMATIONSTRATEGY_H
 #define SIZESPACINGCORRELATIONAPPROXIMATIONSTRATEGY_H
 
-#include "IInterferenceFunctionStrategy.h" // inheriting from
+#include "IInterferenceFunctionStrategy.h"
 
 class SimulationElement;
 
diff --git a/Core/Basics/BornAgainNamespace.h b/Core/Basics/BornAgainNamespace.h
index d5ff7fe8c33b7c48a50fc8e2289a5cbae513eeac..741884afb7b81a4174eb2134baa4264209e4f722 100644
--- a/Core/Basics/BornAgainNamespace.h
+++ b/Core/Basics/BornAgainNamespace.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Basics/BornAgainNamespace.h
-//! @brief     Declares BornAgain namespace
+//! @brief     Defines BornAgain namespace
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Basics/Complex.h b/Core/Basics/Complex.h
index 6abd3e98ee6d1afd51dd695155d4d101a7bc6758..7f74601d8e482475767a06d6007a2d40d2d2c692 100644
--- a/Core/Basics/Complex.h
+++ b/Core/Basics/Complex.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Basics/Complex.h
-//! @brief     Declares complex_t, and a few elementary functions
+//! @brief     Defines complex_t, and a few elementary functions
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Basics/Exceptions.h b/Core/Basics/Exceptions.h
index e62023476fecd9928ee607035859e887b69d8d8b..307c8efd9ce01e8fe890f32e99ac34195e380f21 100644
--- a/Core/Basics/Exceptions.h
+++ b/Core/Basics/Exceptions.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Basics/Exceptions.h
-//! @brief     Declares many exception classes in namespace Exceptions.
+//! @brief     Defines many exception classes in namespace Exceptions.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Basics/ICloneable.h b/Core/Basics/ICloneable.h
index 92385ffd2c61ef483c49c7369c58a2d15f72c017..b8ebd87038b48047c6637bc1658b865c93db4742 100644
--- a/Core/Basics/ICloneable.h
+++ b/Core/Basics/ICloneable.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Basics/ICloneable.h
-//! @brief     Declares the standard mix-in ICloneable.
+//! @brief     Defines the standard mix-in ICloneable.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Basics/IShareable.h b/Core/Basics/IShareable.h
index 8c33d08dcbc122771d8f5cd793aec8634cfe6aa1..560ad55489076d271967a25496be0ac22738c1fb 100644
--- a/Core/Basics/IShareable.h
+++ b/Core/Basics/IShareable.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Basics/IShareable.h
-//! @brief     Declares the class ISharable (used for SWIG smart pointers)
+//! @brief     Defines the class ISharable (used for SWIG smart pointers)
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Basics/ISingleton.h b/Core/Basics/ISingleton.h
index d9c2bb3e7c34fdd88aadeb7769dc75a234796bdb..ce15f6341df98b9decdbb506cd8e742fd2fc731e 100644
--- a/Core/Basics/ISingleton.h
+++ b/Core/Basics/ISingleton.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Basics/ISingleton.h
-//! @brief     Declares the standard mix-in ISingleton.
+//! @brief     Defines the standard mix-in ISingleton.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Basics/Pi.h b/Core/Basics/Pi.h
new file mode 100644
index 0000000000000000000000000000000000000000..325e255d8e6b13e499c2df0e71d608409949be61
--- /dev/null
+++ b/Core/Basics/Pi.h
@@ -0,0 +1,28 @@
+// ************************************************************************** //
+//
+//  BornAgain: simulate and fit scattering at grazing incidence
+//
+//! @file      Core/Basics/Pi.h
+//! @brief     Defines PI and related mathematical constants.
+//!
+//! @homepage  http://www.bornagainproject.org
+//! @license   GNU General Public License v3 or higher (see COPYING)
+//! @copyright Forschungszentrum Jülich GmbH 2015
+//! @authors   Scientific Computing Group at MLZ Garching
+//! @authors   C. Durniak, M. Ganeva, G. Pospelov, W. Van Herck, J. Wuttke
+//
+// ************************************************************************** //
+
+#ifndef PI_H
+#define PI_H
+
+namespace Pi {
+
+static const double PI   = 3.14159265358979323846264338327950288;
+static const double PI2  = 6.28318530717958647692528676655900577;
+static const double PID2 = 1.57079632679489661923132169163975144;
+static const double PID4 = PI/4.0;
+
+} // namespace Pi
+
+#endif // PI_H
diff --git a/Core/Basics/SafePointerVector.h b/Core/Basics/SafePointerVector.h
index 6dd8461cb8353fd0ed08fcf8d945de4d15b06565..9a375e10b50be5d6e58c759c5566ad3c4868b91c 100644
--- a/Core/Basics/SafePointerVector.h
+++ b/Core/Basics/SafePointerVector.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Basics/SafePointerVector.h
-//! @brief     Declares and implements template class SafePointerVector.
+//! @brief     Defines and implements template class SafePointerVector.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Basics/Units.h b/Core/Basics/Units.h
index 4d88c196b0b36eabb03cadbe4f8fedc8d5c4de69..2fa127e25ff2a4cc104bbc83b5a874a1e61d7914 100644
--- a/Core/Basics/Units.h
+++ b/Core/Basics/Units.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Basics/Units.h
-//! @brief     Declares some unit conversion factors and other constants in namespace Units.
+//! @brief     Defines some unit conversion factors and other constants in namespace Units.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -18,13 +18,6 @@
 
 namespace Units {  // BornAgain namespace
 
-// Definitions of Pi and company
-static const double PI          = 3.14159265358979323846264338327950288;
-static const double PI2         = 6.28318530717958647692528676655900577;
-static const double PID2        = 1.57079632679489661923132169163975144;
-static const double PID4        = PI/4.0;
-static const double PI_SQR      = 9.86960440108935861883449099987615114;
-
 // Length
 static const double nanometer   = 1.;
 static const double angstrom    = 1.e-1*nanometer;
@@ -38,7 +31,7 @@ static const double nm  = nanometer;
 // Angle
 static const double radian      = 1.;
 static const double milliradian = 1.e-3*radian;
-static const double degree = (PI/180.0)*radian;
+static const double degree = (3.14159265358979323846264338327950288/180.0)*radian;
 static const double steradian = 1.;
 
 inline double rad2deg(double angle) {return angle/degree; }
@@ -51,8 +44,8 @@ static const double sr   = steradian;
 static const double deg  = degree;
 
 // Magnetic field
-static const double tesla       = 1.;
-static const double gauss       = 1e-4;
+static const double tesla = 1.;
+static const double gauss = 1e-4;
 
 }
 
diff --git a/Core/Binning/Bin.h b/Core/Binning/Bin.h
index 32fd923cad2eb3fb17264d270ff538af2d917514..619abced0083bea3a4b83d021e78e6e4bb44b8e8 100644
--- a/Core/Binning/Bin.h
+++ b/Core/Binning/Bin.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Binning/Bin.h
-//! @brief     Declares structs Bin1D, Bin1DCVector
+//! @brief     Defines structs Bin1D, Bin1DCVector
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Binning/ConstKBinAxis.h b/Core/Binning/ConstKBinAxis.h
index 2510cf192ba2ac82f03be9b888aa057ed73cd9d5..677635a08e5a22250f524944ed48fcea051fc7a1 100644
--- a/Core/Binning/ConstKBinAxis.h
+++ b/Core/Binning/ConstKBinAxis.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Binning/ConstKBinAxis.h
-//! @brief     Declares class ConstKBinAxis.
+//! @brief     Defines class ConstKBinAxis.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef CONSTKBINAXIS_H
 #define CONSTKBINAXIS_H
 
-#include "VariableBinAxis.h" // inheriting from
+#include "VariableBinAxis.h"
 
 //! @class ConstKBinAxis
 //! @ingroup tools
diff --git a/Core/Binning/CustomBinAxis.h b/Core/Binning/CustomBinAxis.h
index 8d27c3637408183757c8b100b3076ba30f1933ae..dc4b6736ac70067a2daf00900b98be7f40f3dd43 100644
--- a/Core/Binning/CustomBinAxis.h
+++ b/Core/Binning/CustomBinAxis.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Binning/CustomBinAxis.h
-//! @brief     Declares class CustomBinAxis.
+//! @brief     Defines class CustomBinAxis.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #define CUSTOMBINAXIS_H
 
 
-#include "VariableBinAxis.h" // inheriting from
+#include "VariableBinAxis.h"
 
 //! @class CustomBinAxis
 //! @ingroup tools
diff --git a/Core/Binning/FixedBinAxis.h b/Core/Binning/FixedBinAxis.h
index b030cad474abd1b41c09fd0531892f2d9fe317e9..11b51f74214285bfd5210824ceed0f07946b0de6 100644
--- a/Core/Binning/FixedBinAxis.h
+++ b/Core/Binning/FixedBinAxis.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Binning/FixedBinAxis.h
-//! @brief     Declares class FixedBinAxis.
+//! @brief     Defines class FixedBinAxis.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #define FIXEDBINAXIS_H
 
 
-#include "IAxis.h" // inheriting from
+#include "IAxis.h"
 
 //! @class FixedBinAxis
 //! @ingroup tools
diff --git a/Core/Binning/IAxis.h b/Core/Binning/IAxis.h
index bc666dbc8f563e4e9cced32feba47973a0a2c242..7a3b06e29cebce20bb7c2a5d0b047b8d399071d4 100644
--- a/Core/Binning/IAxis.h
+++ b/Core/Binning/IAxis.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Binning/IAxis.h
-//! @brief     Declares class IAxis.
+//! @brief     Defines class IAxis.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Binning/VariableBinAxis.h b/Core/Binning/VariableBinAxis.h
index 959e4cc74a2d3ba4feb31f57c5b0a00527a8a188..542b86d8e70e2fdbed67193905c76101ea38045d 100644
--- a/Core/Binning/VariableBinAxis.h
+++ b/Core/Binning/VariableBinAxis.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Binning/VariableBinAxis.h
-//! @brief     Declares class VariableBinAxis.
+//! @brief     Defines class VariableBinAxis.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef VARIABLEBINAXIS_H
 #define VARIABLEBINAXIS_H
 
-#include "IAxis.h" // inheriting from
+#include "IAxis.h"
 
 //! @class VariableBinAxis
 //! @ingroup tools
diff --git a/Core/Export/ExportToPython.h b/Core/Export/ExportToPython.h
index 05d0f81a5dfe29eb9f6c857281fd4efda32e38f6..3afcd55518203e91aa7136266214cf14f40d7b3b 100644
--- a/Core/Export/ExportToPython.h
+++ b/Core/Export/ExportToPython.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Export/ExportToPython.h
-//! @brief     Declares class ExportToPython.
+//! @brief     Defines class ExportToPython.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef EXPORTTOPYTHON_H
 #define EXPORTTOPYTHON_H
 
-#include "ISampleVisitor.h" // inheriting from
+#include "ISampleVisitor.h"
 #include <string>
 
 class GISASSimulation;
diff --git a/Core/Export/PythonFormatting.cpp b/Core/Export/PythonFormatting.cpp
index 67cef7148a6c3c4f4011246d62370b84937bf859..b61eb67d58d7d27064c7e1de1c3fbe7fd67092a2 100644
--- a/Core/Export/PythonFormatting.cpp
+++ b/Core/Export/PythonFormatting.cpp
@@ -29,8 +29,9 @@
 #include "ExportToPython.h"
 #include "RealParameter.h"
 #include "Rectangle.h"
-#include "Units.h"
+#include "Pi.h"
 #include "Utils.h"
+#include "Units.h"
 #include <iomanip>
 GCC_DIAG_OFF(missing-field-initializers)
 GCC_DIAG_OFF(unused-parameter)
@@ -211,8 +212,7 @@ std::string printDegrees(double input)
 {
     std::ostringstream inter;
     inter << std::setprecision(11);
-    double in_degrees = input*180.0/M_PI;
-    inter << in_degrees;
+    inter << Units::rad2deg(input);
     if(inter.str().find('e') == std::string::npos && inter.str().find('.') == std::string::npos)
         inter << ".0";
     inter << "*deg";
@@ -221,12 +221,12 @@ std::string printDegrees(double input)
 
 bool isSquare(double length1, double length2, double angle)
 {
-    return length1==length2 && Numeric::areAlmostEqual(angle, Units::PI/2.0);
+    return length1==length2 && Numeric::areAlmostEqual(angle, Pi::PID2);
 }
 
 bool isHexagonal(double length1, double length2, double angle)
 {
-    return length1==length2 && Numeric::areAlmostEqual(angle, 2*Units::PI/3.0);
+    return length1==length2 && Numeric::areAlmostEqual(angle, Pi::PI2/3.0);
 }
 
 std::string printKvector(const kvector_t value)
diff --git a/Core/Export/PythonFormatting.h b/Core/Export/PythonFormatting.h
index 54ab22e433f6b2ef08bfc39c786394c4f584d258..e822585a26d021fc6c660cfebc17795e43a9a0fc 100644
--- a/Core/Export/PythonFormatting.h
+++ b/Core/Export/PythonFormatting.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Export/PythonFormatting.h
-//! @brief     Declares PythonFormatting namespace.
+//! @brief     Defines PythonFormatting namespace.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Export/SampleLabelHandler.h b/Core/Export/SampleLabelHandler.h
index 80ebf236d2bfbac194a2203d6a177a5efe51553b..2b85922984a921275a6920472c8fe7c1317e645c 100644
--- a/Core/Export/SampleLabelHandler.h
+++ b/Core/Export/SampleLabelHandler.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Export/SampleLabelHandler.h
-//! @brief     Declares SampleLabelHandler class
+//! @brief     Defines SampleLabelHandler class
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Fitting/FitKernel.h b/Core/Fitting/FitKernel.h
index 476b073214ca0550c72ddc86f4ec35521ed62390..88c538a571cb38c4192dd2532cdde1322a8602ea 100644
--- a/Core/Fitting/FitKernel.h
+++ b/Core/Fitting/FitKernel.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Fitting/FitKernel.h
-//! @brief     Declares class FitKernel.
+//! @brief     Defines class FitKernel.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Fitting/FitObject.h b/Core/Fitting/FitObject.h
index f70d9dbf44bfc539118440702a5d1f50375b8376..e86c6a668f2e2684e834fd54d4d00987256cc5a9 100644
--- a/Core/Fitting/FitObject.h
+++ b/Core/Fitting/FitObject.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Fitting/FitObject.h
-//! @brief     Declares class FitObject.
+//! @brief     Defines class FitObject.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef FITOBJECT_H
 #define FITOBJECT_H
 
-#include "IParameterized.h" // inheriting from
+#include "IParameterized.h"
 #include "OutputData.h"
 #include <memory>
 
diff --git a/Core/Fitting/FitOptions.h b/Core/Fitting/FitOptions.h
index 35576086f7ffca184dedccefe85db31f4ff66e3f..45929c1fa0afdbd0ddf6d0cffd29ab22f36fb1eb 100644
--- a/Core/Fitting/FitOptions.h
+++ b/Core/Fitting/FitOptions.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Fitting/FitOptions.h
-//! @brief     Declares class FitOptions.
+//! @brief     Defines class FitOptions.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Fitting/FitStrategyAdjustMinimizer.h b/Core/Fitting/FitStrategyAdjustMinimizer.h
index a527af9b5b61f078ceba0bd2067b142282d392ad..eb7b41b4e468333aa1a156ac7faa41b6d3f3bb85 100644
--- a/Core/Fitting/FitStrategyAdjustMinimizer.h
+++ b/Core/Fitting/FitStrategyAdjustMinimizer.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Fitting/FitStrategyAdjustMinimizer.h
-//! @brief     Declares class FitStrategyAdjustMinimizer
+//! @brief     Defines class FitStrategyAdjustMinimizer
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef FITSTRATEGYADJUSTMINIMIZER_H
 #define FITSTRATEGYADJUSTMINIMIZER_H
 
-#include "IFitStrategy.h" // inheriting from
+#include "IFitStrategy.h"
 
 class IMinimizer;
 class MinimizerOptions;
diff --git a/Core/Fitting/FitStrategyAdjustParameters.h b/Core/Fitting/FitStrategyAdjustParameters.h
index d7487a1d69c58c4d13f0d7b7705d42316d1128f8..25c9f788f0d5a59fa03408071e5390a55d23b346 100644
--- a/Core/Fitting/FitStrategyAdjustParameters.h
+++ b/Core/Fitting/FitStrategyAdjustParameters.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Fitting/FitStrategyAdjustParameters.h
-//! @brief     Declares classes FitStrategyAdjustParameters and related
+//! @brief     Defines classes FitStrategyAdjustParameters and related
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef FITSTRATEGYADJUSTPARAMETERS_H
 #define FITSTRATEGYADJUSTPARAMETERS_H
 
-#include "IFitStrategy.h" // inheriting from
+#include "IFitStrategy.h"
 #include <vector>
 
 //! @class FitStrategyAdjustParameters
diff --git a/Core/Fitting/FitSuite.h b/Core/Fitting/FitSuite.h
index 0dda1d5caf2bfa0a7ce91f64c8d84c9c67a44a99..c68494315fb1a45ffce029d26b73e6e00c66930e 100644
--- a/Core/Fitting/FitSuite.h
+++ b/Core/Fitting/FitSuite.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Fitting/FitSuite.h
-//! @brief     Declares class FitSuite.
+//! @brief     Defines class FitSuite.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Fitting/FitSuiteFunctions.h b/Core/Fitting/FitSuiteFunctions.h
index 49927854fd60588aa060fc97239cce2ab3d35c6f..7d80973077b15f6d8af7e75f8aa30fc78d7fc068 100644
--- a/Core/Fitting/FitSuiteFunctions.h
+++ b/Core/Fitting/FitSuiteFunctions.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Fitting/FitSuiteFunctions.h
-//! @brief     Declares classes IFitSuiteFunction,
+//! @brief     Defines classes IFitSuiteFunction,
 //!              FitSuiteChiSquaredFunction, FitSuiteGradientFunction
 //!
 //! @homepage  http://www.bornagainproject.org
diff --git a/Core/Fitting/FitSuiteObjects.h b/Core/Fitting/FitSuiteObjects.h
index 23f253164f6e0c47a319629ea603be6e9ef43162..57656405a1ec8902cca6e54642ed0437d51b1aff 100644
--- a/Core/Fitting/FitSuiteObjects.h
+++ b/Core/Fitting/FitSuiteObjects.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Fitting/FitSuiteObjects.h
-//! @brief     Declares class FitSuiteObjects.
+//! @brief     Defines class FitSuiteObjects.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Fitting/FitSuitePrintObserver.h b/Core/Fitting/FitSuitePrintObserver.h
index 2c95702a7d7e3fe94f1dcc0580457388cc109175..5f704b30334ce938f0d127ad6780764f51fac044 100644
--- a/Core/Fitting/FitSuitePrintObserver.h
+++ b/Core/Fitting/FitSuitePrintObserver.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Fitting/FitSuitePrintObserver.h
-//! @brief     Declares class FitSuitePrintObserver.
+//! @brief     Defines class FitSuitePrintObserver.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef FITSUITEPRINTOBSERVER_H
 #define FITSUITEPRINTOBSERVER_H
 
-#include "IFitObserver.h" // inheriting from
+#include "IFitObserver.h"
 #include <boost/date_time/posix_time/posix_time.hpp>
 
 //! @class FitSuitePrintObserver
diff --git a/Core/Fitting/FitSuiteStrategies.h b/Core/Fitting/FitSuiteStrategies.h
index 08903c1fb89c634f8a6f60890e4101b4b63e64cf..e1ccf7aee553bd0ac5b499943aec5261032dc899 100644
--- a/Core/Fitting/FitSuiteStrategies.h
+++ b/Core/Fitting/FitSuiteStrategies.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Fitting/FitSuiteStrategies.h
-//! @brief     Declares class FitSuiteStrategies.
+//! @brief     Defines class FitSuiteStrategies.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Fitting/IFitObserver.h b/Core/Fitting/IFitObserver.h
index 5d63267dbae36c111caebb806380bb6b38c46fe9..a0f36d04d00c84b79e071d772a3ce8052f6e0130 100644
--- a/Core/Fitting/IFitObserver.h
+++ b/Core/Fitting/IFitObserver.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Fitting/IFitObserver.h
-//! @brief     Declares class IFitObserver.
+//! @brief     Defines class IFitObserver.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef IFITOBSERVER_H
 #define IFITOBSERVER_H
 
-#include "IObserver.h" // inheriting from
+#include "IObserver.h"
 class FitSuite;
 
 //! @class IFitObserver
diff --git a/Core/Fitting/IFitStrategy.h b/Core/Fitting/IFitStrategy.h
index 540ea241acac2df2be93dc12a3272e32789b43a4..a57f0d48cb15bd2911a9a9bb6bc1eb9d42df37ca 100644
--- a/Core/Fitting/IFitStrategy.h
+++ b/Core/Fitting/IFitStrategy.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Fitting/IFitStrategy.h
-//! @brief     Declares interface class IFitStrategy, and class FitStrategyDefault
+//! @brief     Defines interface class IFitStrategy, and class FitStrategyDefault
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef IFITSTRATEGY_H
 #define IFITSTRATEGY_H
 
-#include "INamed.h" // inheriting from
+#include "INamed.h"
 
 class FitKernel;
 
diff --git a/Core/Fitting/IObserver.h b/Core/Fitting/IObserver.h
index a9ae69258ead2ac1b17a7038d1722c74ace8c7ca..fb476138f220b00daa0f2836515dc9a7b79c6584 100644
--- a/Core/Fitting/IObserver.h
+++ b/Core/Fitting/IObserver.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Fitting/IObserver.h
-//! @brief     Declares classes IObserver and IObservable (Observer pattern).
+//! @brief     Defines classes IObserver and IObservable (Observer pattern).
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/FormFactor/FormFactorDWBA.h b/Core/FormFactor/FormFactorDWBA.h
index 3a65b8cce5d71a12fd7a7f8fab5fe69c3bfdf249..7bd1f35c9e4cd3ccc9d2aaf7634f4e48274aa44c 100644
--- a/Core/FormFactor/FormFactorDWBA.h
+++ b/Core/FormFactor/FormFactorDWBA.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/FormFactor/FormFactorDWBA.h
-//! @brief     Declares class FormFactorDWBA.
+//! @brief     Defines class FormFactorDWBA.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef FORMFACTORDWBA_H
 #define FORMFACTORDWBA_H
 
-#include "IFormFactorDecorator.h" // inheriting from
+#include "IFormFactorDecorator.h"
 
 class ILayerRTCoefficients;
 
diff --git a/Core/FormFactor/FormFactorDWBAPol.h b/Core/FormFactor/FormFactorDWBAPol.h
index ed83b6dbbde065e08f81d653aa65faa51e79c340..40211ae541fe1d12f748623b5aa5b2d1786b8a7c 100644
--- a/Core/FormFactor/FormFactorDWBAPol.h
+++ b/Core/FormFactor/FormFactorDWBAPol.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/FormFactor/FormFactorDWBAPol.h
-//! @brief     Declares class FormFactorDWBAPol.
+//! @brief     Defines class FormFactorDWBAPol.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef FORMFACTORDWBAPOL_H
 #define FORMFACTORDWBAPOL_H
 
-#include "IFormFactor.h" // inheriting from
+#include "IFormFactor.h"
 
 class ILayerRTCoefficients;
 
diff --git a/Core/FormFactor/FormFactorDecoratorDebyeWaller.h b/Core/FormFactor/FormFactorDecoratorDebyeWaller.h
index 3a26cfa95d02067362c447db6a5bd9add805c6bf..98c658c22c49e372b2efd4568472285dd010b226 100644
--- a/Core/FormFactor/FormFactorDecoratorDebyeWaller.h
+++ b/Core/FormFactor/FormFactorDecoratorDebyeWaller.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/FormFactor/FormFactorDecoratorDebyeWaller.h
-//! @brief     Declares and implements class FormFactorDecoratorDebyeWaller.
+//! @brief     Defines and implements class FormFactorDecoratorDebyeWaller.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef FORMFACTORDECORATORDEBYEWALLER_H
 #define FORMFACTORDECORATORDEBYEWALLER_H
 
-#include "IFormFactorDecorator.h" // inheriting from
+#include "IFormFactorDecorator.h"
 
 //! @class FormFactorDecoratorDebyeWaller
 //! @ingroup formfactors_internal
diff --git a/Core/FormFactor/FormFactorDecoratorFactor.h b/Core/FormFactor/FormFactorDecoratorFactor.h
index 0920199b43a58410908dafab63a114fc90ee4ad5..e1a9339af0cf58d5fab0a9d4748c39bc7732ad95 100644
--- a/Core/FormFactor/FormFactorDecoratorFactor.h
+++ b/Core/FormFactor/FormFactorDecoratorFactor.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/FormFactor/FormFactorDecoratorFactor.h
-//! @brief     Declares class FormFactorDecoratorFactor.
+//! @brief     Defines class FormFactorDecoratorFactor.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef FORMFACTORDECORATORFACTOR_H
 #define FORMFACTORDECORATORFACTOR_H
 
-#include "IFormFactorDecorator.h" // inheriting from
+#include "IFormFactorDecorator.h"
 #include "BornAgainNamespace.h"
 
 //! @class FormFactorDecoratorFactor
diff --git a/Core/FormFactor/FormFactorDecoratorMaterial.cpp b/Core/FormFactor/FormFactorDecoratorMaterial.cpp
index 5fee23c95df2bb9137afa010277ddb67f255ac84..a4d26f83fa22e7ac9cab2c8fd836bc4d1494573d 100644
--- a/Core/FormFactor/FormFactorDecoratorMaterial.cpp
+++ b/Core/FormFactor/FormFactorDecoratorMaterial.cpp
@@ -16,7 +16,7 @@
 #include "FormFactorDecoratorMaterial.h"
 #include "IMaterial.h"
 #include "ISampleVisitor.h"
-#include "Units.h"
+#include "Pi.h"
 #include "WavevectorInfo.h"
 
 FormFactorDecoratorMaterial::FormFactorDecoratorMaterial(const IFormFactor& form_factor)
@@ -72,7 +72,7 @@ Eigen::Matrix2cd FormFactorDecoratorMaterial::evaluatePol(const WavevectorInfo&
     time_reverse_conj(1, 0) = -1.0;
     // the interaction and time reversal taken together:
     double wavelength = wavevectors.getWavelength();
-    double k_mag2 = 4.0 * Units::PI * Units::PI / wavelength / wavelength;
+    double k_mag2 = 4.0 * Pi::PI * Pi::PI / wavelength / wavelength;
     Eigen::Matrix2cd V_eff = time_reverse_conj
                              * (mP_material->getScatteringMatrix(k_mag2)
                                 - mP_ambient_material->getScatteringMatrix(k_mag2));
diff --git a/Core/FormFactor/FormFactorDecoratorMaterial.h b/Core/FormFactor/FormFactorDecoratorMaterial.h
index 73f3f1f746bef7bd9ba343fe18c9634f58f47ac2..b96de5f5d032b2c1fc35879d5995957cae12339d 100644
--- a/Core/FormFactor/FormFactorDecoratorMaterial.h
+++ b/Core/FormFactor/FormFactorDecoratorMaterial.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/FormFactor/FormFactorDecoratorMaterial.h
-//! @brief     Declares class FormFactorDecoratorMaterial.
+//! @brief     Defines class FormFactorDecoratorMaterial.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef FORMFACTORDECORATORMATERIAL_H
 #define FORMFACTORDECORATORMATERIAL_H
 
-#include "FormFactorDecoratorFactor.h" // inheriting from
+#include "FormFactorDecoratorFactor.h"
 #include <memory>
 
 class IMaterial;
diff --git a/Core/FormFactor/FormFactorDecoratorMultiPositionFactor.h b/Core/FormFactor/FormFactorDecoratorMultiPositionFactor.h
index 063cd0e764f513db8d6c60e53a095986a67cbc7f..73694541ffe60d309f87ba1298a1912591b25772 100644
--- a/Core/FormFactor/FormFactorDecoratorMultiPositionFactor.h
+++ b/Core/FormFactor/FormFactorDecoratorMultiPositionFactor.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/FormFactor/FormFactorDecoratorMultiPositionFactor.h
-//! @brief     Declares class FormFactorDecoratorMultiPositionFactor.
+//! @brief     Defines class FormFactorDecoratorMultiPositionFactor.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef FORMFACTORDECORATORMULTIPOSITIONFACTOR_H
 #define FORMFACTORDECORATORMULTIPOSITIONFACTOR_H
 
-#include "IFormFactorDecorator.h" // inheriting from
+#include "IFormFactorDecorator.h"
 #include "Vectors3D.h"
 
 //! @class FormFactorDecoratorMultiPositionFactor
diff --git a/Core/FormFactor/FormFactorDecoratorPositionFactor.h b/Core/FormFactor/FormFactorDecoratorPositionFactor.h
index d6c78e149f0d4fd06d15756d49c1e128b4e321d2..61c43e2263cff2199ec4e5c6336d251ce12405d9 100644
--- a/Core/FormFactor/FormFactorDecoratorPositionFactor.h
+++ b/Core/FormFactor/FormFactorDecoratorPositionFactor.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/FormFactor/FormFactorDecoratorPositionFactor.h
-//! @brief     Declares class FormFactorDecoratorPositionFactor.
+//! @brief     Defines class FormFactorDecoratorPositionFactor.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef FORMFACTORDECORATORPOSITIONFACTOR_H
 #define FORMFACTORDECORATORPOSITIONFACTOR_H
 
-#include "IFormFactorDecorator.h" // inheriting from
+#include "IFormFactorDecorator.h"
 #include "Vectors3D.h"
 
 //! @class FormFactorDecoratorPositionFactor
diff --git a/Core/FormFactor/FormFactorDecoratorRotation.h b/Core/FormFactor/FormFactorDecoratorRotation.h
index c5e6419be6dbed62f799bf98f10e1aa558d07c36..ccf5103d47573bab33a09717a47cc48de0e2ef7d 100644
--- a/Core/FormFactor/FormFactorDecoratorRotation.h
+++ b/Core/FormFactor/FormFactorDecoratorRotation.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/FormFactor/FormFactorDecoratorRotation.h
-//! @brief     Declares class FormFactorDecoratorRotation.
+//! @brief     Defines class FormFactorDecoratorRotation.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef FORMFACTORDECORATORROTATION_H
 #define FORMFACTORDECORATORROTATION_H
 
-#include "IFormFactorDecorator.h" // inheriting from
+#include "IFormFactorDecorator.h"
 #include "Rotations.h"
 
 //! @class FormFactorDecoratorRotation
diff --git a/Core/FormFactor/FormFactorTools.h b/Core/FormFactor/FormFactorTools.h
index e10299357358515681eddad93ef5eb2b1d86a7ee..cb65b3a21f31a8713d2b26f146943e607d2078c4 100644
--- a/Core/FormFactor/FormFactorTools.h
+++ b/Core/FormFactor/FormFactorTools.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/FormFactor/FormFactorTools.h
-//! @brief     Declares global functions that facilitate IFormFactor handling.
+//! @brief     Defines global functions that facilitate IFormFactor handling.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/FormFactor/IFormFactorDecorator.h b/Core/FormFactor/IFormFactorDecorator.h
index a264eec57fa45ba98b302468db51fad90f096cc3..e8f7887e7ac9f2058e47292cd40fa1de5674d93d 100644
--- a/Core/FormFactor/IFormFactorDecorator.h
+++ b/Core/FormFactor/IFormFactorDecorator.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/FormFactor/IFormFactorDecorator.h
-//! @brief     Declares pure virtual interface class IFormFactorDecorator.
+//! @brief     Defines pure virtual interface class IFormFactorDecorator.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef IFORMFACTORDECORATOR_H
 #define IFORMFACTORDECORATOR_H
 
-#include "IFormFactor.h" // inheriting from
+#include "IFormFactor.h"
 
 //! @class IFormFactorDecorator
 //! @ingroup formfactors_internal
diff --git a/Core/HardParticle/FormFactorAnisoPyramid.h b/Core/HardParticle/FormFactorAnisoPyramid.h
index de41a210d9efca6fca39ae2a22fad55971d4be5e..156222c9a4aee54e58e2d6ae86c008833e3f182c 100644
--- a/Core/HardParticle/FormFactorAnisoPyramid.h
+++ b/Core/HardParticle/FormFactorAnisoPyramid.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/HardParticle/FormFactorAnisoPyramid.h
-//! @brief     Declares class FormFactorAnisoPyramid
+//! @brief     Defines class FormFactorAnisoPyramid
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef FORMFACTORANISOPYRAMID_H
 #define FORMFACTORANISOPYRAMID_H
 
-#include "FormFactorPolyhedron.h" // inheriting from
+#include "FormFactorPolyhedron.h"
 
 //! @class FormFactorAnisoPyramid
 //! @ingroup formfactors
diff --git a/Core/HardParticle/FormFactorBox.h b/Core/HardParticle/FormFactorBox.h
index 672232541de2484fa2d7bf89afe2781a8e17997b..95290dc5b19219e88e973e33d90078998948129c 100644
--- a/Core/HardParticle/FormFactorBox.h
+++ b/Core/HardParticle/FormFactorBox.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/HardParticle/FormFactorBox.h
-//! @brief     Declares class FormFactorBox.
+//! @brief     Defines class FormFactorBox.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef FORMFACTORBOX_H
 #define FORMFACTORBOX_H
 
-#include "IFormFactorBorn.h" // inheriting from
+#include "IFormFactorBorn.h"
 
 //! @class FormFactorBox
 //! @ingroup formfactors
diff --git a/Core/HardParticle/FormFactorCone.cpp b/Core/HardParticle/FormFactorCone.cpp
index 787c5061040679aceba48bf2432b010f0b9dbb2c..86a9e66dc2951565fe977943efbe239c4c3a564f 100644
--- a/Core/HardParticle/FormFactorCone.cpp
+++ b/Core/HardParticle/FormFactorCone.cpp
@@ -18,7 +18,7 @@
 #include "Exceptions.h"
 #include "MathFunctions.h"
 #include "Numeric.h"
-#include "Units.h"
+#include "Pi.h"
 
 //! @brief Cone constructor
 //! @param radius of Cone's base
@@ -64,10 +64,10 @@ complex_t FormFactorCone::evaluate_for_q(const cvector_t q) const
         double tga = std::tan(m_alpha);
         double HdivRtga = H/tga/R; // TODO preclude division by zero WAITING fuller refactoring
 
-        return  Units::PI/3.0*tga*R*R*R*
+        return  Pi::PI/3.0*tga*R*R*R*
                 (1.0 - (1.0 - HdivRtga)*(1.0 - HdivRtga)*(1.0 - HdivRtga));
     } else {
         complex_t integral = mP_integrator->integrate(0., m_height);
-        return Units::PI2*integral;
+        return Pi::PI2*integral;
     }
 }
diff --git a/Core/HardParticle/FormFactorCone.h b/Core/HardParticle/FormFactorCone.h
index 01894239a4ab0b6f4890320ef49fa71f9fa0badb..b6d17cfa1fdd5748590fd5f5f1be4152f9237336 100644
--- a/Core/HardParticle/FormFactorCone.h
+++ b/Core/HardParticle/FormFactorCone.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/HardParticle/FormFactorCone.h
-//! @brief     Declares class FormFactorCone
+//! @brief     Defines class FormFactorCone
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef FORMFACTORCONE_H
 #define FORMFACTORCONE_H
 
-#include "IFormFactorBorn.h" // inheriting from
+#include "IFormFactorBorn.h"
 #include "IntegratorComplex.h"
 
 class ISampleVisitor;
diff --git a/Core/HardParticle/FormFactorCone6.h b/Core/HardParticle/FormFactorCone6.h
index cfebce0f00a6a33bb0e26da83e32821f9a27b59f..3642da8246e5289f9c227f9702a53404b51dd3c8 100644
--- a/Core/HardParticle/FormFactorCone6.h
+++ b/Core/HardParticle/FormFactorCone6.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/HardParticle/FormFactorCone6.h
-//! @brief     Declares class FormFactorCone6
+//! @brief     Defines class FormFactorCone6
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef FORMFACTORCONE6_H
 #define FORMFACTORCONE6_H
 
-#include "FormFactorPolyhedron.h" // inheriting from
+#include "FormFactorPolyhedron.h"
 
 //! @class FormFactorCone6
 //! @ingroup formfactors
diff --git a/Core/HardParticle/FormFactorCuboctahedron.h b/Core/HardParticle/FormFactorCuboctahedron.h
index 4f2cf33fb4606f66d2c4f9234a27ba844dd45ac8..9e2a172a5cc2380ad6dee3259111c3a59f70eed9 100644
--- a/Core/HardParticle/FormFactorCuboctahedron.h
+++ b/Core/HardParticle/FormFactorCuboctahedron.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/HardParticle/FormFactorCuboctahedron.h
-//! @brief     Declares class FormFactorCuboctahedron
+//! @brief     Defines class FormFactorCuboctahedron
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef FORMFACTORCUBOCTAHEDRON_H
 #define FORMFACTORCUBOCTAHEDRON_H
 
-#include "FormFactorPolyhedron.h" // inheriting from
+#include "FormFactorPolyhedron.h"
 
 //! @class FormFactorCuboctahedron
 //! @ingroup formfactors
diff --git a/Core/HardParticle/FormFactorCylinder.cpp b/Core/HardParticle/FormFactorCylinder.cpp
index d563f3d7283dc0ade2dd8a49ae72b0bd83a7e2cb..65556de7f5142554fa1e8a27aac726a525006c61 100644
--- a/Core/HardParticle/FormFactorCylinder.cpp
+++ b/Core/HardParticle/FormFactorCylinder.cpp
@@ -16,7 +16,7 @@
 #include "FormFactorCylinder.h"
 #include "BornAgainNamespace.h"
 #include "MathFunctions.h"
-#include "Units.h"
+#include "Pi.h"
 
 FormFactorCylinder::FormFactorCylinder(double radius, double height)
     : m_radius(radius), m_height(height)
@@ -34,7 +34,7 @@ complex_t FormFactorCylinder::evaluate_for_q(const cvector_t q) const
     complex_t qzH_half = q.z() * H / 2.0;
     complex_t z_part = H * MathFunctions::sinc(qzH_half) * exp_I(qzH_half);
     complex_t qxy = std::sqrt(q.x() * q.x() + q.y() * q.y());
-    complex_t radial_part = Units::PI2 * R * R * MathFunctions::Bessel_J1c(qxy * R);
+    complex_t radial_part = Pi::PI2 * R * R * MathFunctions::Bessel_J1c(qxy * R);
     complex_t result = radial_part * z_part;
 
     return result;
diff --git a/Core/HardParticle/FormFactorCylinder.h b/Core/HardParticle/FormFactorCylinder.h
index c3d2faa88c5fb95c09a23259ac99e8fb33063e2b..5f115ed4ce3a99f0c3de42f4638927d8b1f7797e 100644
--- a/Core/HardParticle/FormFactorCylinder.h
+++ b/Core/HardParticle/FormFactorCylinder.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/HardParticle/FormFactorCylinder.h
-//! @brief     Declares class FormFactorCylinder.
+//! @brief     Defines class FormFactorCylinder.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef FORMFACTORCYLINDER_H
 #define FORMFACTORCYLINDER_H
 
-#include "IFormFactorBorn.h" // inheriting from
+#include "IFormFactorBorn.h"
 
 //! @class FormFactorCylinder
 //! @ingroup formfactors
diff --git a/Core/HardParticle/FormFactorDodecahedron.h b/Core/HardParticle/FormFactorDodecahedron.h
index 7879d6f3fcbadf0b68160a24975f24d766c954af..c0de7254a3aa564658310fc88331979e95c8b551 100644
--- a/Core/HardParticle/FormFactorDodecahedron.h
+++ b/Core/HardParticle/FormFactorDodecahedron.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/HardParticle/FormFactorDodecahedron.h
-//! @brief     Declares class FormFactorDodecahedron.
+//! @brief     Defines class FormFactorDodecahedron.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef FORMFACTORDODECAHEDRON_H
 #define FORMFACTORDODECAHEDRON_H
 
-#include "FormFactorPolyhedron.h" // inheriting from
+#include "FormFactorPolyhedron.h"
 
 //! @class FormFactorDodecahedron
 //! @ingroup formfactors
diff --git a/Core/HardParticle/FormFactorEllipsoidalCylinder.cpp b/Core/HardParticle/FormFactorEllipsoidalCylinder.cpp
index eb3b4dda62dba929deddb379f25585a5e2e371ef..96c95d111e8530c7f9970b960ad043c71638f072 100644
--- a/Core/HardParticle/FormFactorEllipsoidalCylinder.cpp
+++ b/Core/HardParticle/FormFactorEllipsoidalCylinder.cpp
@@ -16,7 +16,7 @@
 #include "FormFactorEllipsoidalCylinder.h"
 #include "BornAgainNamespace.h"
 #include "MathFunctions.h"
-#include "Units.h"
+#include "Pi.h"
 
 FormFactorEllipsoidalCylinder::FormFactorEllipsoidalCylinder(
     double radius_x, double radius_y, double height)
@@ -43,5 +43,5 @@ complex_t FormFactorEllipsoidalCylinder::evaluate_for_q(const cvector_t q) const
     complex_t gamma  = std::sqrt((qxRa)*(qxRa) + (qyRb)*(qyRb));
     complex_t J1_gamma_div_gamma = MathFunctions::Bessel_J1c(gamma);
 
-    return Units::PI2 *m_radius_x*m_radius_y*m_height * Fz*J1_gamma_div_gamma;
+    return Pi::PI2 *m_radius_x*m_radius_y*m_height * Fz*J1_gamma_div_gamma;
 }
diff --git a/Core/HardParticle/FormFactorEllipsoidalCylinder.h b/Core/HardParticle/FormFactorEllipsoidalCylinder.h
index 2f3506a6d94ef90a3aaf9df7213cc474a50d87cd..b0e3e94c881e829bf409e21c0d3f0da70b89565b 100644
--- a/Core/HardParticle/FormFactorEllipsoidalCylinder.h
+++ b/Core/HardParticle/FormFactorEllipsoidalCylinder.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/HardParticle/FormFactorEllipsoidalCylinder.h
-//! @brief     Declares class FormFactorEllipsoidalCylinder
+//! @brief     Defines class FormFactorEllipsoidalCylinder
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef FORMFACTORELLIPSOIDALCYLINDER_H
 #define FORMFACTORELLIPSOIDALCYLINDER_H
 
-#include "IFormFactorBorn.h" // inheriting from
+#include "IFormFactorBorn.h"
 
 //! @class FormFactorEllipsoidalCylinder
 //! @ingroup formfactors
diff --git a/Core/HardParticle/FormFactorFullSphere.cpp b/Core/HardParticle/FormFactorFullSphere.cpp
index 52573aecb3c90844c92902e518f4ad5ff2986968..4a3d2bcff812d16aebb4b0d1bb4ec2ce3c5d7ac6 100644
--- a/Core/HardParticle/FormFactorFullSphere.cpp
+++ b/Core/HardParticle/FormFactorFullSphere.cpp
@@ -15,7 +15,7 @@
 
 #include "FormFactorFullSphere.h"
 #include "BornAgainNamespace.h"
-#include "Units.h"
+#include "Pi.h"
 
 FormFactorFullSphere::FormFactorFullSphere(double radius)
     : m_radius(radius)
@@ -35,13 +35,13 @@ complex_t FormFactorFullSphere::evaluate_for_q(const cvector_t q) const
 #ifdef POLYHEDRAL_DIAGNOSTIC
         diagnosis = { 0, 1 };
 #endif
-        ret = 4*Units::PI/3*pow(R,3) * ( 1. - 0.1*pow(qR,2) );
+        ret = 4*Pi::PI/3*pow(R,3) * ( 1. - 0.1*pow(qR,2) );
     }
     else {
 #ifdef POLYHEDRAL_DIAGNOSTIC
         diagnosis = { 0, 0 };
 #endif
-        ret = 4*Units::PI*pow(q1,-3)*(sin(qR) - qR*cos(qR));
+        ret = 4*Pi::PI*pow(q1,-3)*(sin(qR) - qR*cos(qR));
     }
 
     return exp_I(q.z()*R) * ret;
diff --git a/Core/HardParticle/FormFactorFullSphere.h b/Core/HardParticle/FormFactorFullSphere.h
index b456c137ef9bc11db9ad99b67cb83f247388262c..86e06b9aa1f41e976bba4862bc135bd23b11e85d 100644
--- a/Core/HardParticle/FormFactorFullSphere.h
+++ b/Core/HardParticle/FormFactorFullSphere.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/HardParticle/FormFactorFullSphere.h
-//! @brief     Declares class FormFactorFullSphere.
+//! @brief     Defines class FormFactorFullSphere.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef FORMFACTORFULLSPHERE_H
 #define FORMFACTORFULLSPHERE_H
 
-#include "IFormFactorBorn.h" // inheriting from
+#include "IFormFactorBorn.h"
 
 //! @ingroup formfactors
 //! @class FormFactorFullSphere
diff --git a/Core/HardParticle/FormFactorFullSpheroid.cpp b/Core/HardParticle/FormFactorFullSpheroid.cpp
index 84db32a48bb73aa2fb6d2c2eda12e426182b430f..797c50fceec343ba7b8313f90d6b51ccbe2140b8 100644
--- a/Core/HardParticle/FormFactorFullSpheroid.cpp
+++ b/Core/HardParticle/FormFactorFullSpheroid.cpp
@@ -17,7 +17,7 @@
 #include "BornAgainNamespace.h"
 #include "MathFunctions.h"
 #include "Numeric.h"
-#include "Units.h"
+#include "Pi.h"
 
 FormFactorFullSpheroid::FormFactorFullSpheroid(double radius, double height )
     : m_radius(radius), m_height(height)
@@ -49,9 +49,9 @@ complex_t FormFactorFullSpheroid::evaluate_for_q(const cvector_t q) const
     m_q = q;
 
     if (std::abs(m_q.mag()) <= Numeric::double_epsilon) {
-        return Units::PI2*R*R*H/3.;
+        return Pi::PI2*R*R*H/3.;
     } else {
         complex_t qzH_half = H/2*q.z();
-        return 4 * Units::PI * mP_integrator->integrate(0.0, H/2.0) * exp_I(qzH_half);
+        return 4 * Pi::PI * mP_integrator->integrate(0.0, H/2.0) * exp_I(qzH_half);
     }
 }
diff --git a/Core/HardParticle/FormFactorFullSpheroid.h b/Core/HardParticle/FormFactorFullSpheroid.h
index 9db486f1c74398e7a231f7e8b9f5bc0442dcb8d8..407fa01b7cd1fbda74921c55e2ba7d2676a2cbc9 100644
--- a/Core/HardParticle/FormFactorFullSpheroid.h
+++ b/Core/HardParticle/FormFactorFullSpheroid.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/HardParticle/FormFactorFullSpheroid.h
-//! @brief     Declares class FormFactorFullSpheroid.
+//! @brief     Defines class FormFactorFullSpheroid.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef FORMFACTORFULLSPHEROID_H
 #define FORMFACTORFULLSPHEROID_H
 
-#include "IFormFactorBorn.h" // inheriting from
+#include "IFormFactorBorn.h"
 #include "IntegratorComplex.h"
 
 //! @class FormFactorFullSpheroid
diff --git a/Core/HardParticle/FormFactorHemiEllipsoid.cpp b/Core/HardParticle/FormFactorHemiEllipsoid.cpp
index c69969f555b31f88bb627634ee5932cf613f27b7..82b9ba8a523ea6fae43f15c1e827d33af9fde6b6 100644
--- a/Core/HardParticle/FormFactorHemiEllipsoid.cpp
+++ b/Core/HardParticle/FormFactorHemiEllipsoid.cpp
@@ -17,7 +17,7 @@
 #include "BornAgainNamespace.h"
 #include "MathFunctions.h"
 #include "Numeric.h"
-#include "Units.h"
+#include "Pi.h"
 
 FormFactorHemiEllipsoid::FormFactorHemiEllipsoid(double radius_x, double radius_y, double height)
     : m_radius_x(radius_x), m_radius_y(radius_y), m_height(height)
@@ -61,8 +61,8 @@ complex_t FormFactorHemiEllipsoid::evaluate_for_q(const cvector_t q) const
      double H = m_height;
 
      if (std::abs(m_q.mag()) <= Numeric::double_epsilon) {
-         return Units::PI2*R*W*H/3.;
+         return Pi::PI2*R*W*H/3.;
      } else {
-         return Units::PI2*mP_integrator->integrate(0.,H );
+         return Pi::PI2*mP_integrator->integrate(0.,H );
      }
 }
diff --git a/Core/HardParticle/FormFactorHemiEllipsoid.h b/Core/HardParticle/FormFactorHemiEllipsoid.h
index ab970f251347ca6bb652233cfbb30ff538b8b96c..9f63e63145ec6ae8fa13f115cbac269c3035925f 100644
--- a/Core/HardParticle/FormFactorHemiEllipsoid.h
+++ b/Core/HardParticle/FormFactorHemiEllipsoid.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/HardParticle/FormFactorHemiEllipsoid.h
-//! @brief     Declares class FormFactorHemiEllipsoid.
+//! @brief     Defines class FormFactorHemiEllipsoid.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef FORMFACTORHEMIELLIPSOID_H
 #define FORMFACTORHEMIELLIPSOID_H
 
-#include "IFormFactorBorn.h" // inheriting from
+#include "IFormFactorBorn.h"
 #include "IntegratorComplex.h"
 
 //! @class FormFactorHemiEllipsoid
diff --git a/Core/HardParticle/FormFactorIcosahedron.h b/Core/HardParticle/FormFactorIcosahedron.h
index 567a8f502e7aa1740c40154193b4be60993301c6..79b95bda693253922e7d955c3c9a99b4f91cb9b5 100644
--- a/Core/HardParticle/FormFactorIcosahedron.h
+++ b/Core/HardParticle/FormFactorIcosahedron.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/HardParticle/FormFactorIcosahedron.h
-//! @brief     Declares class FormFactorIcosahedron.
+//! @brief     Defines class FormFactorIcosahedron.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef FORMFACTORICOSAHEDRON_H
 #define FORMFACTORICOSAHEDRON_H
 
-#include "FormFactorPolyhedron.h" // inheriting from
+#include "FormFactorPolyhedron.h"
 
 //! @class FormFactorIcosahedron
 //! @ingroup formfactors
diff --git a/Core/HardParticle/FormFactorLongBoxGauss.h b/Core/HardParticle/FormFactorLongBoxGauss.h
index 360f260813f6a8232482ae6e0cc1184239e49aa7..1003a41791a745941da220b7e5844cfb62f60496 100644
--- a/Core/HardParticle/FormFactorLongBoxGauss.h
+++ b/Core/HardParticle/FormFactorLongBoxGauss.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/HardParticle/FormFactorLongBoxGauss.h
-//! @brief     Declares class FormFactorLongBoxGauss.
+//! @brief     Defines class FormFactorLongBoxGauss.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef FORMFACTORLONGBOXGAUSS_H
 #define FORMFACTORLONGBOXGAUSS_H
 
-#include "IFormFactorBorn.h" // inheriting from
+#include "IFormFactorBorn.h"
 
 //! @class FormFactorBox
 //! @ingroup formfactors
diff --git a/Core/HardParticle/FormFactorLongBoxLorentz.h b/Core/HardParticle/FormFactorLongBoxLorentz.h
index c7f4296f8321743a9a1b2921a27bce2487a0974e..1dac2e0fae6649bb0c1e71516233d9cc24d0654c 100644
--- a/Core/HardParticle/FormFactorLongBoxLorentz.h
+++ b/Core/HardParticle/FormFactorLongBoxLorentz.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/HardParticle/FormFactorLongBoxLorentz.h
-//! @brief     Declares class FormFactorLongBoxLorentz.
+//! @brief     Defines class FormFactorLongBoxLorentz.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef FORMFACTORLONGBOXLORENTZ_H
 #define FORMFACTORLONGBOXLORENTZ_H
 
-#include "IFormFactorBorn.h" // inheriting from
+#include "IFormFactorBorn.h"
 
 //! @class FormFactorBox
 //! @ingroup formfactors
diff --git a/Core/HardParticle/FormFactorLongRipple1Gauss.cpp b/Core/HardParticle/FormFactorLongRipple1Gauss.cpp
index 5253f7c58bb1c3d9ae13d0c1042abcf01b4d9ebe..86988dbc6146ab4c7fbdd9e2ad8d974f6c8782a0 100644
--- a/Core/HardParticle/FormFactorLongRipple1Gauss.cpp
+++ b/Core/HardParticle/FormFactorLongRipple1Gauss.cpp
@@ -18,7 +18,7 @@
 #include "BornAgainNamespace.h"
 #include "Exceptions.h"
 #include "MathFunctions.h"
-#include "Units.h"
+#include "Pi.h"
 
 FormFactorLongRipple1Gauss::FormFactorLongRipple1Gauss(double length, double width, double height)
     : m_length(length), m_width(width), m_height(height)
@@ -55,27 +55,27 @@ double FormFactorLongRipple1Gauss::getRadialExtension() const
 complex_t FormFactorLongRipple1Gauss::Integrand(double Z) const
 {
     complex_t aa = std::acos(2.0*Z/m_height - 1.0);
-    return exp_I(m_q.z()*Z)*aa*MathFunctions::sinc(aa*m_q.y()*m_width/(Units::PI2));
+    return exp_I(m_q.z()*Z)*aa*MathFunctions::sinc(aa*m_q.y()*m_width/(Pi::PI2));
 }
 
 //! Complex formfactor.
 complex_t FormFactorLongRipple1Gauss::evaluate_for_q(const cvector_t q) const
 {
     m_q = q;
-//    complex_t factor = m_length*MathFunctions::sinc(m_q.x()*m_length*0.5)*m_width/Units::PI;
+//    complex_t factor = m_length*MathFunctions::sinc(m_q.x()*m_length*0.5)*m_width/Pi::PI;
     complex_t qxL2 = std::pow(m_length * q.x(), 2) / 2.0;
-    complex_t factor = m_length*std::exp(-qxL2)*m_width/Units::PI;
+    complex_t factor = m_length*std::exp(-qxL2)*m_width/Pi::PI;
 
-    complex_t aaa = m_q.y()*m_width/(Units::PI2);
+    complex_t aaa = m_q.y()*m_width/(Pi::PI2);
     complex_t aaa2 = aaa*aaa;
 
     // analytical expressions for some particular cases
     if (0.0==m_q.y() && 0.0==m_q.z())
-        return factor*Units::PID2*m_height;
+        return factor*Pi::PID2*m_height;
     else if (0.0==m_q.z() && 1.0 == aaa2)
-        return factor*Units::PID4*m_height;
+        return factor*Pi::PID4*m_height;
     else if (0.0==m_q.z())
-        return factor*Units::PID2*m_height*MathFunctions::sinc(m_q.y()*m_width*0.5)/(1.0-aaa2);
+        return factor*Pi::PID2*m_height*MathFunctions::sinc(m_q.y()*m_width*0.5)/(1.0-aaa2);
 
     // numerical integration otherwise
     complex_t integral = mP_integrator->integrate(0, m_height);
diff --git a/Core/HardParticle/FormFactorLongRipple1Gauss.h b/Core/HardParticle/FormFactorLongRipple1Gauss.h
index 1cef3a397f5be20fc58012fde83125f2fc6483ea..dbf8f5db6b2f2667af29d5ffc6787ff1c0ffa706 100644
--- a/Core/HardParticle/FormFactorLongRipple1Gauss.h
+++ b/Core/HardParticle/FormFactorLongRipple1Gauss.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/HardParticle/FormFactorLongRipple1Gauss.h
-//! @brief     Declares class FormFactorLongRipple1Gauss.
+//! @brief     Defines class FormFactorLongRipple1Gauss.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef FORMFACTORLONGRIPPLE1GAUSS_H
 #define FORMFACTORLONGRIPPLE1GAUSS_H
 
-#include "IFormFactorBorn.h" // inheriting from
+#include "IFormFactorBorn.h"
 #include "IntegratorComplex.h"
 
 //! @class FormFactorLongRipple1Gauss
diff --git a/Core/HardParticle/FormFactorLongRipple1Lorentz.cpp b/Core/HardParticle/FormFactorLongRipple1Lorentz.cpp
index 64be51c6c0415c82b9c584a9635612d02786a393..e4bb8a6ad3dcdacc30ca33a60ef32ab03cb0f809 100644
--- a/Core/HardParticle/FormFactorLongRipple1Lorentz.cpp
+++ b/Core/HardParticle/FormFactorLongRipple1Lorentz.cpp
@@ -17,7 +17,7 @@
 #include "BornAgainNamespace.h"
 #include "Exceptions.h"
 #include "MathFunctions.h"
-#include "Units.h"
+#include "Pi.h"
 
 FormFactorLongRipple1Lorentz::FormFactorLongRipple1Lorentz(
     double length, double width, double height)
@@ -55,7 +55,7 @@ double FormFactorLongRipple1Lorentz::getRadialExtension() const
 complex_t FormFactorLongRipple1Lorentz::Integrand(double Z) const
 {
     complex_t aa = std::acos(2.0*Z/m_height - 1.0);
-    return exp_I(m_q.z()*Z) * aa * MathFunctions::sinc(aa*m_q.y() * m_width/(Units::PI2));
+    return exp_I(m_q.z()*Z) * aa * MathFunctions::sinc(aa*m_q.y() * m_width/(Pi::PI2));
 }
 
 //! Complex formfactor.
@@ -64,18 +64,18 @@ complex_t FormFactorLongRipple1Lorentz::evaluate_for_q(const cvector_t q) const
     m_q = q;
 
     complex_t qxL2 = 2.5*std::pow(m_length * q.x(), 2);
-    complex_t factor = m_length/(1.0 + qxL2)*m_width/Units::PI;
+    complex_t factor = m_length/(1.0 + qxL2)*m_width/Pi::PI;
 
-    complex_t aaa = q.y()*m_width/(Units::PI2);
+    complex_t aaa = q.y()*m_width/(Pi::PI2);
     complex_t aaa2 = aaa*aaa;
 
     // analytical expressions for some particular cases
     if (0.0==q.y() && 0.0==q.z())
-        return factor*Units::PID2*m_height;
+        return factor*Pi::PID2*m_height;
     else if (0.0==q.z() && 1.0 == aaa2)
-        return factor*Units::PID4*m_height;
+        return factor*Pi::PID4*m_height;
     else if (0.0==q.z())
-        return factor*Units::PID2*m_height*MathFunctions::sinc(q.y()*m_width*0.5)/(1.0-aaa2);
+        return factor*Pi::PID2*m_height*MathFunctions::sinc(q.y()*m_width*0.5)/(1.0-aaa2);
 
     // numerical integration otherwise
     complex_t integral = mP_integrator->integrate(0, m_height);
diff --git a/Core/HardParticle/FormFactorLongRipple1Lorentz.h b/Core/HardParticle/FormFactorLongRipple1Lorentz.h
index de908efef11b9e9546360a50fe710c345db8d3a9..448c6483d39ceca66e4ea9da97ce4a91acc98ded 100644
--- a/Core/HardParticle/FormFactorLongRipple1Lorentz.h
+++ b/Core/HardParticle/FormFactorLongRipple1Lorentz.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/HardParticle/FormFactorLongRipple1Lorentz.h
-//! @brief     Declares class FormFactorLongRipple1Lorentz.
+//! @brief     Defines class FormFactorLongRipple1Lorentz.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef FORMFACTORLONGRIPPLE1LORENTZ_H
 #define FORMFACTORLONGRIPPLE1LORENTZ_H
 
-#include "IFormFactorBorn.h" // inheriting from
+#include "IFormFactorBorn.h"
 #include "IntegratorComplex.h"
 
 //! @class FormFactorLongRipple1Lorentz
diff --git a/Core/HardParticle/FormFactorLongRipple2Gauss.h b/Core/HardParticle/FormFactorLongRipple2Gauss.h
index 129a7c5a98d98c5e51481e77f0dc171c60838554..f3fad4401ba96833be533f0a67445ced852b52de 100644
--- a/Core/HardParticle/FormFactorLongRipple2Gauss.h
+++ b/Core/HardParticle/FormFactorLongRipple2Gauss.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/HardParticle/FormFactorLongRipple2Gauss.h
-//! @brief     Declares class FormFactorLongRipple2Gauss.
+//! @brief     Defines class FormFactorLongRipple2Gauss.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef FORMFACTORLONGRIPPLE2GAUSS_H
 #define FORMFACTORLONGRIPPLE2GAUSS_H
 
-#include "IFormFactorBorn.h" // inheriting from
+#include "IFormFactorBorn.h"
 
 //! @class FormFactorLongRipple2Gauss
 //! @ingroup formfactors
diff --git a/Core/HardParticle/FormFactorLongRipple2Lorentz.h b/Core/HardParticle/FormFactorLongRipple2Lorentz.h
index 9a076a71893b53c29299e35de6f82900f3f10dd8..cf2cc831f5bd2322201b244ec1af968f1796440d 100644
--- a/Core/HardParticle/FormFactorLongRipple2Lorentz.h
+++ b/Core/HardParticle/FormFactorLongRipple2Lorentz.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/HardParticle/FormFactorLongRipple2Lorentz.h
-//! @brief     Declares class FormFactorLongRipple2Lorentz.
+//! @brief     Defines class FormFactorLongRipple2Lorentz.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef FORMFACTORLONGRIPPLE2LORENTZ_H
 #define FORMFACTORLONGRIPPLE2LORENTZ_H
 
-#include "IFormFactorBorn.h" // inheriting from
+#include "IFormFactorBorn.h"
 
 //! @class FormFactorLongRipple2Lorentz
 //! @ingroup formfactors
diff --git a/Core/HardParticle/FormFactorPolyhedron.h b/Core/HardParticle/FormFactorPolyhedron.h
index 998ebbe9d67628c561a325547f44e5aa45855714..03781099c200e029151df0b22e18483fec2e427c 100644
--- a/Core/HardParticle/FormFactorPolyhedron.h
+++ b/Core/HardParticle/FormFactorPolyhedron.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/HardParticle/FormFactorPolyhedron.h
-//! @brief     Declares class FormFactorPolyhedron, FormFactorPrism, and auxiliary classes.
+//! @brief     Defines class FormFactorPolyhedron, FormFactorPrism, and auxiliary classes.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef FORMFACTORPOLYHEDRON_H
 #define FORMFACTORPOLYHEDRON_H
 
-#include "IFormFactorBorn.h" // inheriting from
+#include "IFormFactorBorn.h"
 #include <memory>
 
 class PolygonalTopology {
diff --git a/Core/HardParticle/FormFactorPrism3.h b/Core/HardParticle/FormFactorPrism3.h
index 8c39389f0809ea22e497967f81f9282f1ea5b9a5..b68585b69e8ae1d0ff75d61f07f05f295a99080a 100644
--- a/Core/HardParticle/FormFactorPrism3.h
+++ b/Core/HardParticle/FormFactorPrism3.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/HardParticle/FormFactorPrism3.h
-//! @brief     Declares class FormFactorPrism3.
+//! @brief     Defines class FormFactorPrism3.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/HardParticle/FormFactorPrism6.h b/Core/HardParticle/FormFactorPrism6.h
index caa4c35f59e2e22ae1ff0461ba3d0d1667234cc9..0db28218d61e836564a924a0de7727d55a136744 100644
--- a/Core/HardParticle/FormFactorPrism6.h
+++ b/Core/HardParticle/FormFactorPrism6.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/HardParticle/FormFactorPrism6.h
-//! @brief     Declares class FormFactorPrism6.
+//! @brief     Defines class FormFactorPrism6.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/HardParticle/FormFactorPyramid.h b/Core/HardParticle/FormFactorPyramid.h
index 088ff2d357164aa4b63d47699a0031883b311d53..f0cd19eb3dc8c39efca6995f4803325a966d65cb 100644
--- a/Core/HardParticle/FormFactorPyramid.h
+++ b/Core/HardParticle/FormFactorPyramid.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/HardParticle/FormFactorPyramid.h
-//! @brief     Declares class FormFactorPyramid
+//! @brief     Defines class FormFactorPyramid
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef FORMFACTORPYRAMID_H
 #define FORMFACTORPYRAMID_H
 
-#include "FormFactorPolyhedron.h" // inheriting from
+#include "FormFactorPolyhedron.h"
 
 //! @class FormFactorPyramid
 //! @ingroup formfactors
diff --git a/Core/HardParticle/FormFactorRipple1.cpp b/Core/HardParticle/FormFactorRipple1.cpp
index 6965b4e4eeaeda4d9d20eb9be062f7723cc23d92..9dc3fada6d56b9f17458b5a929dfead4b183dc6b 100644
--- a/Core/HardParticle/FormFactorRipple1.cpp
+++ b/Core/HardParticle/FormFactorRipple1.cpp
@@ -18,7 +18,7 @@
 #include "BornAgainNamespace.h"
 #include "Exceptions.h"
 #include "MathFunctions.h"
-#include "Units.h"
+#include "Pi.h"
 
 static complex_t I(0.,1.);
 
@@ -62,22 +62,22 @@ complex_t FormFactorRipple1::Integrand(double u) const
 //! Complex formfactor.
 complex_t FormFactorRipple1::evaluate_for_q(const cvector_t q) const
 {
-    complex_t factor = m_length*MathFunctions::sinc(q.x()*m_length*0.5)*m_width/Units::PI;
+    complex_t factor = m_length*MathFunctions::sinc(q.x()*m_length*0.5)*m_width/Pi::PI;
 
     // analytical expressions for some particular cases
     if ( q.z()==0. ) {
         if( q.y()==0. )
-            return factor*Units::PID2*m_height;
-        complex_t aaa = q.y()*m_width/(Units::PI2);
+            return factor*Pi::PID2*m_height;
+        complex_t aaa = q.y()*m_width/(Pi::PI2);
         complex_t aaa2 = aaa*aaa;
         if ( aaa2==1. )
-            return factor*Units::PID4*m_height;
-        return factor*Units::PID2*m_height*MathFunctions::sinc(q.y()*m_width*0.5)/(1.0-aaa2);
+            return factor*Pi::PID4*m_height;
+        return factor*Pi::PID2*m_height*MathFunctions::sinc(q.y()*m_width*0.5)/(1.0-aaa2);
     }
 
     // numerical integration otherwise
-    m_ay = q.y() * m_width / Units::PI2;
+    m_ay = q.y() * m_width / Pi::PI2;
     m_az = I * q.z() * (m_height/2);
-    complex_t integral = mP_integrator->integrate(0, Units::PI);
+    complex_t integral = mP_integrator->integrate(0, Pi::PI);
     return factor * integral * exp(m_az) * (m_height/2);
 }
diff --git a/Core/HardParticle/FormFactorRipple1.h b/Core/HardParticle/FormFactorRipple1.h
index 9b950a09857a8d8393cc87dff377052cc7a98a2f..ca71bc49545133e92d58708afb59416fd87a11ff 100644
--- a/Core/HardParticle/FormFactorRipple1.h
+++ b/Core/HardParticle/FormFactorRipple1.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/HardParticle/FormFactorRipple1.h
-//! @brief     Declares class FormFactorRipple1.
+//! @brief     Defines class FormFactorRipple1.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef FORMFACTORRIPPLE1_H
 #define FORMFACTORRIPPLE1_H
 
-#include "IFormFactorBorn.h" // inheriting from
+#include "IFormFactorBorn.h"
 #include "IntegratorComplex.h"
 
 //! @class FormFactorRipple1
diff --git a/Core/HardParticle/FormFactorRipple2.h b/Core/HardParticle/FormFactorRipple2.h
index 8bf6062b1724bdc2330ba3cce1415e46858cb496..e9809a65344acf6f6efdd746c1c63b46bd6b5698 100644
--- a/Core/HardParticle/FormFactorRipple2.h
+++ b/Core/HardParticle/FormFactorRipple2.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/HardParticle/FormFactorRipple2.h
-//! @brief     Declares class FormFactorRipple2.
+//! @brief     Defines class FormFactorRipple2.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef FORMFACTORRIPPLE2_H
 #define FORMFACTORRIPPLE2_H
 
-#include "IFormFactorBorn.h" // inheriting from
+#include "IFormFactorBorn.h"
 
 //! @class FormFactorRipple2
 //! @ingroup formfactors
diff --git a/Core/HardParticle/FormFactorTetrahedron.h b/Core/HardParticle/FormFactorTetrahedron.h
index 66529ef6fe44241857192dcfc44cc9a649d34b3f..7c23348e1f5e68bf62b48282955f027c26c27fba 100644
--- a/Core/HardParticle/FormFactorTetrahedron.h
+++ b/Core/HardParticle/FormFactorTetrahedron.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/HardParticle/FormFactorTetrahedron.h
-//! @brief     Declares class FormFactorTetrahedron
+//! @brief     Defines class FormFactorTetrahedron
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef FORMFACTORTETRAHEDRON_H
 #define FORMFACTORTETRAHEDRON_H
 
-#include "FormFactorPolyhedron.h" // inheriting from
+#include "FormFactorPolyhedron.h"
 
 //! @class FormFactorTetrahedron
 //! @ingroup formfactors
diff --git a/Core/HardParticle/FormFactorTriangle.h b/Core/HardParticle/FormFactorTriangle.h
index 1730ea6408823c7a84941729878f0bb83b4ef331..3a78449c5c805e33c0f1a0e6552218527477f42e 100644
--- a/Core/HardParticle/FormFactorTriangle.h
+++ b/Core/HardParticle/FormFactorTriangle.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/HardParticle/FormFactorTriangle.h
-//! @brief     Declares class FormFactorTriangle.
+//! @brief     Defines class FormFactorTriangle.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/HardParticle/FormFactorTrivial.h b/Core/HardParticle/FormFactorTrivial.h
index b2f02eaa23e312cd8a7e025aeb7ceeb811df822a..052e31065bed365c22c68807b6ff092d63bf8e06 100644
--- a/Core/HardParticle/FormFactorTrivial.h
+++ b/Core/HardParticle/FormFactorTrivial.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/HardParticle/FormFactorTrivial.h
-//! @brief     Declares class FormFactorTrivial.
+//! @brief     Defines class FormFactorTrivial.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef FORMFACTORTRIVIAL_H
 #define FORMFACTORTRIVIAL_H
 
-#include "IFormFactorBorn.h" // inheriting from
+#include "IFormFactorBorn.h"
 
 //! @class FormFactorTrivial
 //! @ingroup formfactors
diff --git a/Core/HardParticle/FormFactorTruncatedCube.h b/Core/HardParticle/FormFactorTruncatedCube.h
index 298997cc3009e5f540aefa0bde5266b5ea12da4f..a52b174c1bc9311ffaddcfd73557b8b2c63cdbab 100644
--- a/Core/HardParticle/FormFactorTruncatedCube.h
+++ b/Core/HardParticle/FormFactorTruncatedCube.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/HardParticle/FormFactorTruncatedCube.h
-//! @brief     Declares class FormFactorTruncatedCube.
+//! @brief     Defines class FormFactorTruncatedCube.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef FORMFACTORTRUNCATEDCUBE_H
 #define FORMFACTORTRUNCATEDCUBE_H
 
-#include "FormFactorPolyhedron.h" // inheriting from
+#include "FormFactorPolyhedron.h"
 
 //! @class FormFactorTruncatedCube
 //! @ingroup formfactors
diff --git a/Core/HardParticle/FormFactorTruncatedSphere.cpp b/Core/HardParticle/FormFactorTruncatedSphere.cpp
index 2f2dd577cee0ae62b5e8741b0b1fff4810c6bdd1..4586f483f1aaf6a5b3634180a027285f5cf0ce3d 100644
--- a/Core/HardParticle/FormFactorTruncatedSphere.cpp
+++ b/Core/HardParticle/FormFactorTruncatedSphere.cpp
@@ -19,7 +19,7 @@
 #include "Exceptions.h"
 #include "MathFunctions.h"
 #include "Numeric.h"
-#include "Units.h"
+#include "Pi.h"
 
 using namespace  BornAgain;
 
@@ -64,10 +64,10 @@ complex_t FormFactorTruncatedSphere::evaluate_for_q(const cvector_t q) const
     m_q = q;
     if ( std::abs(q.mag()) < Numeric::double_epsilon) {
         double HdivR = m_height/m_radius;
-        return Units::PI/3.*m_radius*m_radius*m_radius
+        return Pi::PI/3.*m_radius*m_radius*m_radius
                 *(3.*HdivR -1. - (HdivR - 1.)*(HdivR - 1.)*(HdivR - 1.));
     }
     // else
     complex_t integral = mP_integrator->integrate(m_radius-m_height, m_radius);
-    return Units::PI2 * integral * exp_I(q.z()*(m_height-m_radius));
+    return Pi::PI2 * integral * exp_I(q.z()*(m_height-m_radius));
 }
diff --git a/Core/HardParticle/FormFactorTruncatedSphere.h b/Core/HardParticle/FormFactorTruncatedSphere.h
index 4cc9379068ffed260465490f4c3737960b55cae4..5b0e2de46a666059115f0164338168fd36135aac 100644
--- a/Core/HardParticle/FormFactorTruncatedSphere.h
+++ b/Core/HardParticle/FormFactorTruncatedSphere.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/HardParticle/FormFactorTruncatedSphere.h
-//! @brief     Declares class FormFactorTruncatedSphere.
+//! @brief     Defines class FormFactorTruncatedSphere.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef FORMFACTORTRUNCATEDSPHERE_H
 #define FORMFACTORTRUNCATEDSPHERE_H
 
-#include "IFormFactorBorn.h" // inheriting from
+#include "IFormFactorBorn.h"
 #include "IntegratorComplex.h"
 
 //! @class FormFactorTruncatedSphere
diff --git a/Core/HardParticle/FormFactorTruncatedSpheroid.cpp b/Core/HardParticle/FormFactorTruncatedSpheroid.cpp
index 42f39493ec0c2dc476b47f6c773f64d6e51ed28e..66b8520095365232b1852d9cc91f02da8658befb 100644
--- a/Core/HardParticle/FormFactorTruncatedSpheroid.cpp
+++ b/Core/HardParticle/FormFactorTruncatedSpheroid.cpp
@@ -18,7 +18,7 @@
 #include "Exceptions.h"
 #include "MathFunctions.h"
 #include "Numeric.h"
-#include "Units.h"
+#include "Pi.h"
 
 FormFactorTruncatedSpheroid::FormFactorTruncatedSpheroid(
     double radius, double height, double height_flattening)
@@ -68,9 +68,9 @@ complex_t FormFactorTruncatedSpheroid::evaluate_for_q(const cvector_t q) const
     m_q = q;
 
     if (std::abs(m_q.mag()) <= Numeric::double_epsilon) {
-        return Units::PI*R*H*H/fp*(1.-H/(3.*fp*R));
+        return Pi::PI*R*H*H/fp*(1.-H/(3.*fp*R));
     } else {
         complex_t z_part    =  std::exp(complex_t(0.0, 1.0)*m_q.z()*(H-fp*R));
-        return Units::PI2 * z_part *mP_integrator->integrate(fp*R-H,fp*R );
+        return Pi::PI2 * z_part *mP_integrator->integrate(fp*R-H,fp*R );
     }
 }
diff --git a/Core/HardParticle/FormFactorTruncatedSpheroid.h b/Core/HardParticle/FormFactorTruncatedSpheroid.h
index 7c9e2b19262408fd4f623ca694143f70e3eba28e..d2d6eb69923b94d91e805368e824ecdd4fe06484 100644
--- a/Core/HardParticle/FormFactorTruncatedSpheroid.h
+++ b/Core/HardParticle/FormFactorTruncatedSpheroid.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/HardParticle/FormFactorTruncatedSpheroid.h
-//! @brief     Declares class FormFactorTruncatedSpheroid.
+//! @brief     Defines class FormFactorTruncatedSpheroid.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef FORMFACTORTRUNCATEDSPHEROID_H
 #define FORMFACTORTRUNCATEDSPHEROID_H
 
-#include "IFormFactorBorn.h" // inheriting from
+#include "IFormFactorBorn.h"
 #include "IntegratorComplex.h"
 
 //! @class FormFactorTruncatedSpheroid
diff --git a/Core/InputOutput/IntensityDataIOFactory.h b/Core/InputOutput/IntensityDataIOFactory.h
index b18db4befc834401820499d6c2d462cbe085154c..0de20eec8b3a617668f568e95a08252d4cb86e53 100644
--- a/Core/InputOutput/IntensityDataIOFactory.h
+++ b/Core/InputOutput/IntensityDataIOFactory.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/InputOutput/IntensityDataIOFactory.h
-//! @brief     Declares class IntensityDataIOFactory.
+//! @brief     Defines class IntensityDataIOFactory.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/InputOutput/OutputDataIOHelper.h b/Core/InputOutput/OutputDataIOHelper.h
index 3e1b105439f468bdb1454b4960ab589c8837b28f..e4b4649e2f43b13d860c30d6481c7468c8421ca1 100644
--- a/Core/InputOutput/OutputDataIOHelper.h
+++ b/Core/InputOutput/OutputDataIOHelper.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/InputOutput/OutputDataIOHelper.h
-//! @brief     Declares class OutputDataIOFactory.
+//! @brief     Defines class OutputDataIOFactory.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/InputOutput/OutputDataReadFactory.h b/Core/InputOutput/OutputDataReadFactory.h
index 75de8ab52c77e7f216c508e448b4b20401008add..d0701baf6ff90041f67fe09ca2127b6c4a37844e 100644
--- a/Core/InputOutput/OutputDataReadFactory.h
+++ b/Core/InputOutput/OutputDataReadFactory.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/InputOutput/OutputDataReadFactory.h
-//! @brief     Declares class OutputDataReadFactory.
+//! @brief     Defines class OutputDataReadFactory.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/InputOutput/OutputDataReadStrategy.h b/Core/InputOutput/OutputDataReadStrategy.h
index 24169682eba8c570af9d57a4c7e9d736ff911b50..75fdf1c68e311cc4bd113cf9204827f59f0dd392 100644
--- a/Core/InputOutput/OutputDataReadStrategy.h
+++ b/Core/InputOutput/OutputDataReadStrategy.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/InputOutput/OutputDataReadStrategy.h
-//! @brief     Declares IOutputDataReadStrategy and related classes.
+//! @brief     Defines IOutputDataReadStrategy and related classes.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/InputOutput/OutputDataReader.h b/Core/InputOutput/OutputDataReader.h
index ed7c69471c62923749a55c3cea248b6ea781256c..3705ff65d4aea07998ff2ff87ba439630a769c48 100644
--- a/Core/InputOutput/OutputDataReader.h
+++ b/Core/InputOutput/OutputDataReader.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/InputOutput/OutputDataReader.h
-//! @brief     Declares class OutputDataReader.
+//! @brief     Defines class OutputDataReader.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/InputOutput/OutputDataWriteFactory.h b/Core/InputOutput/OutputDataWriteFactory.h
index cdf1503ecc50b5dd7e4403d74d38578462fe8c92..ca9ad0144c7657e5201439f87e469ec7fa96bdc9 100644
--- a/Core/InputOutput/OutputDataWriteFactory.h
+++ b/Core/InputOutput/OutputDataWriteFactory.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/InputOutput/OutputDataWriteFactory.h
-//! @brief     Declares class OutputDataWriteFactory.
+//! @brief     Defines class OutputDataWriteFactory.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/InputOutput/OutputDataWriteStrategy.h b/Core/InputOutput/OutputDataWriteStrategy.h
index 8d22c178e29eaf4fcdb81ab162d65a8c9bf510c3..9f6af19dd5ac36f5b6864a1e9818395c4ae850fd 100644
--- a/Core/InputOutput/OutputDataWriteStrategy.h
+++ b/Core/InputOutput/OutputDataWriteStrategy.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/InputOutput/OutputDataWriteStrategy.h
-//! @brief     Declares classes IOutputDataWriteStrategy and OutputDataWriteStreamIMA.
+//! @brief     Defines classes IOutputDataWriteStrategy and OutputDataWriteStreamIMA.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/InputOutput/OutputDataWriter.h b/Core/InputOutput/OutputDataWriter.h
index bc28d0b8caf8fe7f292ddf257a1aca45be688e69..cb39ba641c6e1be0172c0d018c9c72f48623512a 100644
--- a/Core/InputOutput/OutputDataWriter.h
+++ b/Core/InputOutput/OutputDataWriter.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/InputOutput/OutputDataWriter.h
-//! @brief     Declares class OutputDataWriter.
+//! @brief     Defines class OutputDataWriter.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/InputOutput/TiffHandler.h b/Core/InputOutput/TiffHandler.h
index 54ff07397f35557b38caf8c1efea89f83a58ec6b..5ce4a6b82e02c7d6bc7bb4413dd47cd43812c3f2 100644
--- a/Core/InputOutput/TiffHandler.h
+++ b/Core/InputOutput/TiffHandler.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/InputOutput/TiffHandler.h
-//! @brief     Declares class TiffHandler.
+//! @brief     Defines class TiffHandler.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Instrument/Beam.h b/Core/Instrument/Beam.h
index 160ad8131d31a6fdab35ec690187866d0f07e6b3..86064231edfb40973313524bf61a1d3efaa24555 100644
--- a/Core/Instrument/Beam.h
+++ b/Core/Instrument/Beam.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Instrument/Beam.h
-//! @brief     Declares class Beam.
+//! @brief     Defines class Beam.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef BEAM_H
 #define BEAM_H
 
-#include "IParameterized.h" // inheriting from
+#include "IParameterized.h"
 #include "EigenCore.h"
 #include "Vectors3D.h"
 
diff --git a/Core/Instrument/ChiSquaredModule.h b/Core/Instrument/ChiSquaredModule.h
index 183da9e69d0d99b4c577785edbbd565d35ac3cb5..16b20b088ed61230c09a635ae2fa5664a13183d1 100644
--- a/Core/Instrument/ChiSquaredModule.h
+++ b/Core/Instrument/ChiSquaredModule.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Instrument/ChiSquaredModule.h
-//! @brief     Declares class ChiSquaredModule.
+//! @brief     Defines class ChiSquaredModule.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef CHISQUAREDMODULE_H
 #define CHISQUAREDMODULE_H
 
-#include "IChiSquaredModule.h" // inheriting from
+#include "IChiSquaredModule.h"
 
 //! @class ChiSquaredModule
 //! @ingroup algorithms
diff --git a/Core/Instrument/ConvolutionDetectorResolution.h b/Core/Instrument/ConvolutionDetectorResolution.h
index d7576f417633d7dc02a242c1a5ce8ede6cb19139..ae58d37dbb1bcc798eb7a7e0f664da3a1feed157 100644
--- a/Core/Instrument/ConvolutionDetectorResolution.h
+++ b/Core/Instrument/ConvolutionDetectorResolution.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Instrument/ConvolutionDetectorResolution.h
-//! @brief     Declares class ConvolutionDetectorResolution.
+//! @brief     Defines class ConvolutionDetectorResolution.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef CONVOLUTIONDETECTORRESOLUTION_H
 #define CONVOLUTIONDETECTORRESOLUTION_H
 
-#include "IDetectorResolution.h" // inheriting from
+#include "IDetectorResolution.h"
 #include "IResolutionFunction2D.h"
 
 //! @class ConvolutionDetectorResolution
diff --git a/Core/Instrument/Convolve.h b/Core/Instrument/Convolve.h
index 54a4624e1df173df101fcd62856fd1c03beb7711..a8447253ececf73b2c6d42ccb2b6c9560e1950c6 100644
--- a/Core/Instrument/Convolve.h
+++ b/Core/Instrument/Convolve.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Instrument/Convolve.h
-//! @brief     Declares class MathFunctions::Convolve.
+//! @brief     Defines class MathFunctions::Convolve.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Instrument/CumulativeValue.h b/Core/Instrument/CumulativeValue.h
index a4908d398c9892c9f2c8da0252ee0e534de67b41..650d371443620780e565fa1f627f66b5517cb962 100644
--- a/Core/Instrument/CumulativeValue.h
+++ b/Core/Instrument/CumulativeValue.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Instrument/CumulativeValue.h
-//! @brief     Declares class CumulativeValue.
+//! @brief     Defines class CumulativeValue.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Instrument/DetectorMask.h b/Core/Instrument/DetectorMask.h
index e3e846559bdd0ce29c67a1d0401fb5ee0f3928d3..5609f0f5e32e70eb30a69485c841af5324090331 100644
--- a/Core/Instrument/DetectorMask.h
+++ b/Core/Instrument/DetectorMask.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Instrument/DetectorMask.h
-//! @brief     Declares class DetectorMask.
+//! @brief     Defines class DetectorMask.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Instrument/FitElement.h b/Core/Instrument/FitElement.h
index 30bc34297405c6b0dd7afac2d7db0456e65d3745..c0591c865bccc5a765de8e2cc8c61373e3484850 100644
--- a/Core/Instrument/FitElement.h
+++ b/Core/Instrument/FitElement.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Instrument/FitElement.h
-//! @brief     Declares class FitElement.
+//! @brief     Defines class FitElement.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Instrument/Histogram1D.h b/Core/Instrument/Histogram1D.h
index 0f54da679999ad70b877ecc07744087f935c86c5..73e37814145655154cd268de32d435ac984f122d 100644
--- a/Core/Instrument/Histogram1D.h
+++ b/Core/Instrument/Histogram1D.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Instrument/Histogram1D.h
-//! @brief     Declares class Histogram1D.
+//! @brief     Defines class Histogram1D.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef HISTOGRAM1D_H
 #define HISTOGRAM1D_H
 
-#include "IHistogram.h" // inheriting from
+#include "IHistogram.h"
 
 ////! @class Histogram1D
 ////! @ingroup tools
diff --git a/Core/Instrument/Histogram2D.h b/Core/Instrument/Histogram2D.h
index 30ebc02f9c31f71cd483c1816051979ac3c2b0bb..9b1984bc91f80ae913dacf608dc789ae69c54bff 100644
--- a/Core/Instrument/Histogram2D.h
+++ b/Core/Instrument/Histogram2D.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Instrument/Histogram2D.h
-//! @brief     Declares class Histogram2D.
+//! @brief     Defines class Histogram2D.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef HISTOGRAM2D_H
 #define HISTOGRAM2D_H
 
-#include "IHistogram.h" // inheriting from
+#include "IHistogram.h"
 
 #ifdef BORNAGAIN_PYTHON
 #ifndef PyObject_HEAD
diff --git a/Core/Instrument/IChiSquaredModule.h b/Core/Instrument/IChiSquaredModule.h
index c6bfe74e55a80a7c001f35c2eab5256301171e08..5ca142b818a1c0e81faa3465fad826f1e9ce4a62 100644
--- a/Core/Instrument/IChiSquaredModule.h
+++ b/Core/Instrument/IChiSquaredModule.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Instrument/IChiSquaredModule.h
-//! @brief     Declares class IChiSquaredModule.
+//! @brief     Defines class IChiSquaredModule.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Instrument/IDetector2D.h b/Core/Instrument/IDetector2D.h
index 656fa6edf61c7f7b360388a4aecfe32d904797df..9527026dddf91dd21c23183702df8d460b966efd 100644
--- a/Core/Instrument/IDetector2D.h
+++ b/Core/Instrument/IDetector2D.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Instrument/IDetector2D.h
-//! @brief     Declares interface IDetector2D.
+//! @brief     Defines interface IDetector2D.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef IDETECTOR2D_H
 #define IDETECTOR2D_H
 
-#include "IParameterized.h" // inheriting from
+#include "IParameterized.h"
 #include "Beam.h"
 #include "DetectorMask.h"
 #include "EigenCore.h"
diff --git a/Core/Instrument/IDetectorResolution.h b/Core/Instrument/IDetectorResolution.h
index e14ca18f1d6230754c867e160d505c8948f0d5b7..1a915c69d46528a6035f93e1953c9ec2e4b3ca64 100644
--- a/Core/Instrument/IDetectorResolution.h
+++ b/Core/Instrument/IDetectorResolution.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Instrument/IDetectorResolution.h
-//! @brief     Declares class IDetectorResolution.
+//! @brief     Defines class IDetectorResolution.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Instrument/IHistogram.h b/Core/Instrument/IHistogram.h
index aa96adee523ad2c4993c2f3eca6d2ef4d1733b8e..c2e8c4b4cfc38c9670eb322af33273f3e468194e 100644
--- a/Core/Instrument/IHistogram.h
+++ b/Core/Instrument/IHistogram.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Instrument/IHistogram.h
-//! @brief     Declares class IHistogram.
+//! @brief     Defines class IHistogram.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Instrument/IIntensityFunction.h b/Core/Instrument/IIntensityFunction.h
index 15a9ecd6af013523d0e40c9d564d5a8dc0e56679..164c9a2c18974af8e1b3b3cf9229174565ecbbfd 100644
--- a/Core/Instrument/IIntensityFunction.h
+++ b/Core/Instrument/IIntensityFunction.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Instrument/IIntensityFunction.h
-//! @brief     Declares and implements the interface class IIntensityFunction
+//! @brief     Defines and implements the interface class IIntensityFunction
 //!            and its child classes IntensityFunctionLog, IntensityFunctionSqrt
 //!
 //! @homepage  http://www.bornagainproject.org
diff --git a/Core/Instrument/IIntensityNormalizer.h b/Core/Instrument/IIntensityNormalizer.h
index 7dcd54bfaa50545219ba40a78874db16bd14a1d1..f074fd7b0326167c112946798060e320f72cd827 100644
--- a/Core/Instrument/IIntensityNormalizer.h
+++ b/Core/Instrument/IIntensityNormalizer.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Instrument/IIntensityNormalizer.h
-//! @brief     Declares classes IOutputDataNormalizer,
+//! @brief     Defines classes IOutputDataNormalizer,
 //!              OutputDataNormalizer, OutputDataSimpleNormalizer.
 //!
 //! @homepage  http://www.bornagainproject.org
@@ -17,7 +17,7 @@
 #ifndef IINTENSITYNORMALIZER_H
 #define IINTENSITYNORMALIZER_H
 
-#include "IParameterized.h" // inheriting from
+#include "IParameterized.h"
 #include "OutputData.h"
 
 
diff --git a/Core/Instrument/IPixelMap.h b/Core/Instrument/IPixelMap.h
index 901686b660f7d675f2c9a377a121fcdd6f000b0e..47101d33b6cb0bd4577e0e29445b724ca91a7c96 100644
--- a/Core/Instrument/IPixelMap.h
+++ b/Core/Instrument/IPixelMap.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Instrument/IPixelMap.h
-//! @brief     Declares interface IPixelMap.
+//! @brief     Defines interface IPixelMap.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Instrument/IResolutionFunction2D.h b/Core/Instrument/IResolutionFunction2D.h
index 30e977310145094135dc6a20ae4dded6eb012e20..d3047da2916ace7cf3f5a9de3c2fc66ca3ad2f91 100644
--- a/Core/Instrument/IResolutionFunction2D.h
+++ b/Core/Instrument/IResolutionFunction2D.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Instrument/IResolutionFunction2D.h
-//! @brief     Declares interface class IResolutionFunction2D.
+//! @brief     Defines interface class IResolutionFunction2D.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef IRESOLUTIONFUNCTION2D_H
 #define IRESOLUTIONFUNCTION2D_H
 
-#include "IParameterized.h" // inheriting from
+#include "IParameterized.h"
 
 //! @class IResolutionFunction2D
 //! @ingroup algorithms_internal
diff --git a/Core/Instrument/ISquaredFunction.h b/Core/Instrument/ISquaredFunction.h
index bdcb72414de9b3ee4b5ca726e5fff3369e99f9fa..7352fa1dc38cc1e3512bf0ea95fed2b6e43bd309 100644
--- a/Core/Instrument/ISquaredFunction.h
+++ b/Core/Instrument/ISquaredFunction.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Instrument/ISquaredFunction.h
-//! @brief     Declares classes ISquaredFunction, SquaredFunctionDefault, ...
+//! @brief     Defines classes ISquaredFunction, SquaredFunctionDefault, ...
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Instrument/Instrument.h b/Core/Instrument/Instrument.h
index 2e4e7c291c01dc4b981ca6ac669153b393cfcf87..82d2b0e09e78a58d522fd1affc8ae1e2536f02b8 100644
--- a/Core/Instrument/Instrument.h
+++ b/Core/Instrument/Instrument.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Instrument/Instrument.h
-//! @brief     Declares class Instrument.
+//! @brief     Defines class Instrument.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef INSTRUMENT_H
 #define INSTRUMENT_H
 
-#include "IParameterized.h" // inheriting from
+#include "IParameterized.h"
 #include "Beam.h"
 #include "IDetector2D.h"
 #include <memory>
diff --git a/Core/Instrument/IntensityDataFunctions.h b/Core/Instrument/IntensityDataFunctions.h
index 96973b9a1981fa024d86e798a8765253c0f8d836..1310be1f46bf0eaac73df4acf8d2df4609f7848c 100644
--- a/Core/Instrument/IntensityDataFunctions.h
+++ b/Core/Instrument/IntensityDataFunctions.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Instrument/IntensityDataFunctions.h
-//! @brief     Declares class IntensityDataFunctions.
+//! @brief     Defines class IntensityDataFunctions.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Instrument/IsGISAXSDetector.h b/Core/Instrument/IsGISAXSDetector.h
index b0d5b53ca0206bc83cc08336156b186501e12f08..52a91e1879a29b10a96aedcc9ae9f64a85b4d0b6 100644
--- a/Core/Instrument/IsGISAXSDetector.h
+++ b/Core/Instrument/IsGISAXSDetector.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Instrument/IsGISAXSDetector.h
-//! @brief     Declares class IsGISAXSDetector.
+//! @brief     Defines class IsGISAXSDetector.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef ISGISAXSDETECTOR_H
 #define ISGISAXSDETECTOR_H
 
-#include "SphericalDetector.h" // inheriting from
+#include "SphericalDetector.h"
 
 //! @class IsGISAXSDetector
 //! @ingroup simulation
diff --git a/Core/Instrument/LLData.h b/Core/Instrument/LLData.h
index d6fda02c9e833bccee2f885aa1e5b35bc7fceba3..baeba9435b78c2ba7af68578853f5a7501654e15 100644
--- a/Core/Instrument/LLData.h
+++ b/Core/Instrument/LLData.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Instrument/LLData.h
-//! @brief     Declares class LLData.
+//! @brief     Defines class LLData.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Instrument/OutputData.h b/Core/Instrument/OutputData.h
index e1c55881efcab7b79bf33a9bfb1a438f16960bdd..490d46305c65d30b15045ada165371f919f9e3f7 100644
--- a/Core/Instrument/OutputData.h
+++ b/Core/Instrument/OutputData.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Instrument/OutputData.h
-//! @brief     Declares and implements template class OutputData.
+//! @brief     Defines and implements template class OutputData.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Instrument/OutputDataFunctions.h b/Core/Instrument/OutputDataFunctions.h
index 53b035d6d39605454bb20b8d2dd1badb2c7729bd..ac1aef44b3e69f729ba4c62c546cd536cca5b32d 100644
--- a/Core/Instrument/OutputDataFunctions.h
+++ b/Core/Instrument/OutputDataFunctions.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Instrument/OutputDataFunctions.h
-//! @brief     Declares functions in namespace OutputDataFunctions.
+//! @brief     Defines functions in namespace OutputDataFunctions.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Instrument/OutputDataIterator.h b/Core/Instrument/OutputDataIterator.h
index 905baa8f29340108eaf8b8ab736cfa8c1a121e37..6cefa955da7ff9058dfceb496dbee7657ed89b39 100644
--- a/Core/Instrument/OutputDataIterator.h
+++ b/Core/Instrument/OutputDataIterator.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Instrument/OutputDataIterator.h
-//! @brief     Declares and implements template class OutputDataIterator.
+//! @brief     Defines and implements template class OutputDataIterator.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Instrument/RectangularDetector.cpp b/Core/Instrument/RectangularDetector.cpp
index cc3ebe0334c94133ad05af2f0f1f8ae3321eaacf..c42bd99712abb6867c3b0c71005badad667ff145 100644
--- a/Core/Instrument/RectangularDetector.cpp
+++ b/Core/Instrument/RectangularDetector.cpp
@@ -18,6 +18,7 @@
 #include "BornAgainNamespace.h"
 #include "IDetectorResolution.h"
 #include "SimulationElement.h"
+#include "Pi.h"
 #include "Units.h"
 
 RectangularDetector::RectangularDetector(int nxbins, double width, int nybins, double height)
@@ -406,7 +407,7 @@ RectPixelMap *RectPixelMap::createZeroSizeMap(double x, double y) const
 kvector_t RectPixelMap::getK(double x, double y, double wavelength) const
 {
     kvector_t direction = m_corner_pos + x*m_width + y*m_height;
-    double length = 2.0*M_PI/wavelength;
+    double length = PI2/wavelength;
     return normalizeLength(direction, length);
 }
 
diff --git a/Core/Instrument/RectangularDetector.h b/Core/Instrument/RectangularDetector.h
index 5e420b9a2d0a1dd358ad70fbe758a18c7268c0e8..b1b3dce265dc8fa66b829e9d785f8dbf77e95264 100644
--- a/Core/Instrument/RectangularDetector.h
+++ b/Core/Instrument/RectangularDetector.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Instrument/RectangularDetector.h
-//! @brief     Declares class RectangularDetector.
+//! @brief     Defines class RectangularDetector.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,8 +16,8 @@
 #ifndef RECTANGULARDETECTOR_H
 #define RECTANGULARDETECTOR_H
 
-#include "IDetector2D.h" // inheriting from
-#include "IPixelMap.h" // inheriting from
+#include "IDetector2D.h"
+#include "IPixelMap.h"
 
 //! @class RectangularDetector
 //! @ingroup simulation
diff --git a/Core/Instrument/ResolutionFunction2DGaussian.h b/Core/Instrument/ResolutionFunction2DGaussian.h
index d304fd7b226d17ae24218cfc3b1f8d4de8191ea2..f636b38a2b9a5246ec5a7b15ad5f247ea0f9b069 100644
--- a/Core/Instrument/ResolutionFunction2DGaussian.h
+++ b/Core/Instrument/ResolutionFunction2DGaussian.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Instrument/ResolutionFunction2DGaussian.h
-//! @brief     Declares class ResolutionFunction2DGaussian.
+//! @brief     Defines class ResolutionFunction2DGaussian.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef RESOLUTIONFUNCTION2DGAUSSIAN_H
 #define RESOLUTIONFUNCTION2DGAUSSIAN_H
 
-#include "IResolutionFunction2D.h" // inheriting from
+#include "IResolutionFunction2D.h"
 
 //! @class ResolutionFunction2DGaussian
 //! @ingroup algorithms_internal
diff --git a/Core/Instrument/SimulationElement.cpp b/Core/Instrument/SimulationElement.cpp
index e74ee561791450bc70ecd96de3ee3ce8b8303678..16bf0bc0917c705dd2f185ca1f614bb857b78476 100644
--- a/Core/Instrument/SimulationElement.cpp
+++ b/Core/Instrument/SimulationElement.cpp
@@ -15,6 +15,7 @@
 
 #include "SimulationElement.h"
 #include "IPixelMap.h"
+#include "Pi.h"
 #include <vector>
 
 SimulationElement::SimulationElement(double wavelength, double alpha_i, double phi_i,
@@ -76,13 +77,13 @@ kvector_t SimulationElement::getQ(double x, double y) const
 
 void SimulationElement::swapContent(SimulationElement &other)
 {
-    std::swap(this->m_wavelength, other.m_wavelength);
-    std::swap(this->m_alpha_i, other.m_alpha_i);
-    std::swap(this->m_phi_i, other.m_phi_i);
-    std::swap(this->m_intensity, other.m_intensity);
-    std::swap(this->m_polarization, other.m_polarization);
-    std::swap(this->m_analyzer_operator, other.m_analyzer_operator);
-    std::swap(this->mP_pixel_map, other.mP_pixel_map);
+    std::swap(m_wavelength, other.m_wavelength);
+    std::swap(m_alpha_i, other.m_alpha_i);
+    std::swap(m_phi_i, other.m_phi_i);
+    std::swap(m_intensity, other.m_intensity);
+    std::swap(m_polarization, other.m_polarization);
+    std::swap(m_analyzer_operator, other.m_analyzer_operator);
+    std::swap(mP_pixel_map, other.mP_pixel_map);
 }
 
 void SimulationElement::initPolarization()
@@ -93,7 +94,7 @@ void SimulationElement::initPolarization()
 
 double SimulationElement::getAlpha(double x, double y) const
 {
-    return M_PI_2 - getK(x,y).theta();
+    return Pi::PID2 - getK(x,y).theta();
 }
 
 double SimulationElement::getPhi(double x, double y) const
diff --git a/Core/Instrument/SimulationElement.h b/Core/Instrument/SimulationElement.h
index e1a959c67153bd225f1b62c440f7de2d6a8a5c4d..283ce3ddacbd19328f17edf0ae6dfdebf431de8e 100644
--- a/Core/Instrument/SimulationElement.h
+++ b/Core/Instrument/SimulationElement.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Instrument/SimulationElement.h
-//! @brief     Declares class SimulationElement.
+//! @brief     Defines class SimulationElement.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Instrument/SphericalDetector.h b/Core/Instrument/SphericalDetector.h
index 26e430a20fbb8bd8bf32a536ae06e8ab1c71cd2c..3699ffb2c1d6f33c30e1793b9d7a6a964c3353d5 100644
--- a/Core/Instrument/SphericalDetector.h
+++ b/Core/Instrument/SphericalDetector.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Instrument/SphericalDetector.h
-//! @brief     Declares class SphericalDetector.
+//! @brief     Defines class SphericalDetector.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,8 +16,8 @@
 #ifndef SPHERICALDETECTOR_H
 #define SPHERICALDETECTOR_H
 
-#include "IDetector2D.h" // inheriting from
-#include "IPixelMap.h" // inheriting from
+#include "IDetector2D.h"
+#include "IPixelMap.h"
 
 //! @class SphericalDetector
 //! @ingroup simulation
diff --git a/Core/Lattice/ISelectionRule.h b/Core/Lattice/ISelectionRule.h
index 92473f94f7c4ae455ec6e0690c6b3a09e8bd9279..e63aea2290d5d925b681769d315d81090b681d7b 100644
--- a/Core/Lattice/ISelectionRule.h
+++ b/Core/Lattice/ISelectionRule.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Lattice/ISelectionRule.h
-//! @brief     Declares classes ISelectionRule, SimpleSelectionRule
+//! @brief     Defines classes ISelectionRule, SimpleSelectionRule
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Lattice/Lattice.cpp b/Core/Lattice/Lattice.cpp
index 767fc8b1e3d4ddf0bda762040c24a440aa760045..26338b524bd9cb98832a1afa2ad2565ea8d49cec 100644
--- a/Core/Lattice/Lattice.cpp
+++ b/Core/Lattice/Lattice.cpp
@@ -15,7 +15,7 @@
 
 #include "Lattice.h"
 #include "ISelectionRule.h"
-#include "Units.h"
+#include "Pi.h"
 #include <gsl/gsl_linalg.h>
 
 Lattice::Lattice()
@@ -90,9 +90,9 @@ void Lattice::getReciprocalLatticeBasis(kvector_t b1, kvector_t b2,
 
 ivector_t Lattice::getNearestLatticeVectorCoordinates(const kvector_t vector_in) const
 {
-    double a1_coord = vector_in.dot(m_b1)/Units::PI2;
-    double a2_coord = vector_in.dot(m_b2)/Units::PI2;
-    double a3_coord = vector_in.dot(m_b3)/Units::PI2;
+    double a1_coord = vector_in.dot(m_b1)/Pi::PI2;
+    double a2_coord = vector_in.dot(m_b2)/Pi::PI2;
+    double a3_coord = vector_in.dot(m_b3)/Pi::PI2;
     int c1 = (int)std::floor(a1_coord + 0.5);
     int c2 = (int)std::floor(a2_coord + 0.5);
     int c3 = (int)std::floor(a3_coord + 0.5);
@@ -102,9 +102,9 @@ ivector_t Lattice::getNearestLatticeVectorCoordinates(const kvector_t vector_in)
 ivector_t Lattice::getNearestReciprocalLatticeVectorCoordinates(
         const kvector_t vector_in) const
 {
-    double b1_coord = vector_in.dot(m_a1)/Units::PI2;
-    double b2_coord = vector_in.dot(m_a2)/Units::PI2;
-    double b3_coord = vector_in.dot(m_a3)/Units::PI2;
+    double b1_coord = vector_in.dot(m_a1)/Pi::PI2;
+    double b2_coord = vector_in.dot(m_a2)/Pi::PI2;
+    double b3_coord = vector_in.dot(m_a3)/Pi::PI2;
     int c1 = (int)std::floor(b1_coord + 0.5);
     int c2 = (int)std::floor(b2_coord + 0.5);
     int c3 = (int)std::floor(b3_coord + 0.5);
@@ -145,9 +145,9 @@ void Lattice::computeReciprocalVectors() const
     kvector_t a23 = m_a2.cross(m_a3);
     kvector_t a31 = m_a3.cross(m_a1);
     kvector_t a12 = m_a1.cross(m_a2);
-    m_b1 = Units::PI2/m_a1.dot(a23)*a23;
-    m_b2 = Units::PI2/m_a2.dot(a31)*a31;
-    m_b3 = Units::PI2/m_a3.dot(a12)*a12;
+    m_b1 = Pi::PI2/m_a1.dot(a23)*a23;
+    m_b2 = Pi::PI2/m_a2.dot(a31)*a31;
+    m_b3 = Pi::PI2/m_a3.dot(a12)*a12;
 }
 
 void Lattice::computeVectorsWithinRadius(const kvector_t input_vector,
@@ -155,9 +155,9 @@ void Lattice::computeVectorsWithinRadius(const kvector_t input_vector,
         const kvector_t v2, const kvector_t v3, const kvector_t rec1,
         const kvector_t rec2, const kvector_t rec3) const
 {
-    int max_X = (int)std::floor( rec1.mag()*radius/Units::PI2 );
-    int max_Y = (int)std::floor( rec2.mag()*radius/Units::PI2 );
-    int max_Z = (int)std::floor( rec3.mag()*radius/Units::PI2 );
+    int max_X = (int)std::floor( rec1.mag()*radius/Pi::PI2 );
+    int max_Y = (int)std::floor( rec2.mag()*radius/Pi::PI2 );
+    int max_Z = (int)std::floor( rec3.mag()*radius/Pi::PI2 );
 
     m_kvector_container.clear();
     for (int index_X = -max_X; index_X <= max_X; ++index_X)
diff --git a/Core/Lattice/Lattice.h b/Core/Lattice/Lattice.h
index 937fa1db1833ec0667390ec274fb6488639949c2..7a492de9f3a88826c5b52010d10b0c115104cc0a 100644
--- a/Core/Lattice/Lattice.h
+++ b/Core/Lattice/Lattice.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Lattice/Lattice.h
-//! @brief     Declares class Lattice.
+//! @brief     Defines class Lattice.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Lattice/Lattice1DParameters.h b/Core/Lattice/Lattice1DParameters.h
index cfd11f7d2bdbbfa5cde2c4cbfff0f2574a949eff..b5ef8d15cb32ca7d7e7a8a98fe0bb20dff5ff7f3 100644
--- a/Core/Lattice/Lattice1DParameters.h
+++ b/Core/Lattice/Lattice1DParameters.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Lattice/Lattice1DParameters.h
-//! @brief     Declares class Lattice1DParameters.
+//! @brief     Defines class Lattice1DParameters.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Lattice/Lattice2DParameters.h b/Core/Lattice/Lattice2DParameters.h
index 383ce8dc6d2734047a225c24ac1ef6c735713a02..5f459a4a2f42c751853a8ed3a8653fca40b479bb 100644
--- a/Core/Lattice/Lattice2DParameters.h
+++ b/Core/Lattice/Lattice2DParameters.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Lattice/Lattice2DParameters.h
-//! @brief     Declares class Lattice2DParameters.
+//! @brief     Defines class Lattice2DParameters.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Mask/Ellipse.h b/Core/Mask/Ellipse.h
index deb6097ce43d0dbe18826197134e6c1cc1b972bf..8a87be4a31299174f9d28bdd9ade6acba4d7af90 100644
--- a/Core/Mask/Ellipse.h
+++ b/Core/Mask/Ellipse.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Mask/Ellipse.h
-//! @brief     Declares class Rectangle.
+//! @brief     Defines class Rectangle.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef ELLIPSE_H
 #define ELLIPSE_H
 
-#include "IShape2D.h" // inheriting from
+#include "IShape2D.h"
 
 namespace Geometry {
 
diff --git a/Core/Mask/IShape2D.h b/Core/Mask/IShape2D.h
index a247d71ceaa14a546f1517c5b9fa803ab10c57cf..d6df66af82c69c63c3affbefb4f73101e60de65c 100644
--- a/Core/Mask/IShape2D.h
+++ b/Core/Mask/IShape2D.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Mask/IShape2D.h
-//! @brief     Declares basic class for all 2D shapes.
+//! @brief     Defines basic class for all 2D shapes.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef ISHAPE2D_H
 #define ISHAPE2D_H
 
-#include "ICloneable.h" // inheriting from
+#include "ICloneable.h"
 #include <iostream>
 
 struct Bin1D;
diff --git a/Core/Mask/InfinitePlane.h b/Core/Mask/InfinitePlane.h
index 023e1da5bb4c2566fadd36716325d2b0cc94a574..27ae4cec079187167d9c177b0d107a481d525066 100644
--- a/Core/Mask/InfinitePlane.h
+++ b/Core/Mask/InfinitePlane.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Mask/InfinitePlane.h
-//! @brief     Declares class InfinitePlane.
+//! @brief     Defines class InfinitePlane.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef INFINITEPLANE_H
 #define INFINITEPLANE_H
 
-#include "IShape2D.h" // inheriting from
+#include "IShape2D.h"
 
 namespace Geometry {
 
diff --git a/Core/Mask/Line.h b/Core/Mask/Line.h
index c3a0a08e3406ea882e30109f0ddf42deaf965f24..121a24cc4ca0c16503d477f7210edb943e15438d 100644
--- a/Core/Mask/Line.h
+++ b/Core/Mask/Line.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Mask/Line.h
-//! @brief     Declares class Line.
+//! @brief     Defines class Line.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef LINE_H
 #define LINE_H
 
-#include "IShape2D.h" // inheriting from
+#include "IShape2D.h"
 
 namespace Geometry {
 
diff --git a/Core/Mask/Mask.h b/Core/Mask/Mask.h
index 7e6b1a86271e2eb4f868edbf9c956a0ddd09b694..94213ac15d91d253a5f2973082f2aaf2571d5cc3 100644
--- a/Core/Mask/Mask.h
+++ b/Core/Mask/Mask.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Mask/Mask.h
-//! @brief     Declares classes Mask, MaskIndexModulus, MaskCoordinates.
+//! @brief     Defines classes Mask, MaskIndexModulus, MaskCoordinates.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef MASK_H
 #define MASK_H
 
-#include "ICloneable.h" // inheriting from
+#include "ICloneable.h"
 #include <cstddef>
 
 using std::size_t;
diff --git a/Core/Mask/MaskCoordinateFunction.h b/Core/Mask/MaskCoordinateFunction.h
index d071930117e8a0e31507c0ac7876035486a1c1da..835f407e12884662530f71098ce1d7b2b1144e25 100644
--- a/Core/Mask/MaskCoordinateFunction.h
+++ b/Core/Mask/MaskCoordinateFunction.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Mask/MaskCoordinateFunction.h
-//! @brief     Declares classes MaskCoordinateFunction,
+//! @brief     Defines classes MaskCoordinateFunction,
 //!              MaskCoordinateRectangleFunction, MaskCoordinateEllipseFunction
 //!
 //! @homepage  http://www.bornagainproject.org
@@ -17,7 +17,7 @@
 #ifndef MASKCOORDINATEFUNCTION_H
 #define MASKCOORDINATEFUNCTION_H
 
-#include "ICloneable.h" // inheriting from
+#include "ICloneable.h"
 #include <cstddef>
 
 using std::size_t;
diff --git a/Core/Mask/Polygon.h b/Core/Mask/Polygon.h
index 4b15ef5c65064f3dbae884e3c44609231cd8b37f..a0844e04c91cfc893fc52503e4549d46c66adbf1 100644
--- a/Core/Mask/Polygon.h
+++ b/Core/Mask/Polygon.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Mask/Polygon.h
-//! @brief     Declares class Polygon.
+//! @brief     Defines class Polygon.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef POLYGON_H
 #define POLYGON_H
 
-#include "IShape2D.h" // inheriting from
+#include "IShape2D.h"
 #include <vector>
 
 namespace Geometry {
diff --git a/Core/Mask/Rectangle.h b/Core/Mask/Rectangle.h
index 091502ac895bbe791f4cca0567da682b17af1307..b894c936096364bbdabba30f94bae38371f0e4de 100644
--- a/Core/Mask/Rectangle.h
+++ b/Core/Mask/Rectangle.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Mask/Rectangle.h
-//! @brief     Declares class Rectangle.
+//! @brief     Defines class Rectangle.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef RECTANGLE_H
 #define RECTANGLE_H
 
-#include "IShape2D.h" // inheriting from
+#include "IShape2D.h"
 
 namespace Geometry {
 
diff --git a/Core/Material/HomogeneousMagneticMaterial.h b/Core/Material/HomogeneousMagneticMaterial.h
index ac6b4015116f6ec06558bac890de1ebb678c0e72..046566211d0481202cf8dce0139bcdb79cdd5c91 100644
--- a/Core/Material/HomogeneousMagneticMaterial.h
+++ b/Core/Material/HomogeneousMagneticMaterial.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Material/HomogeneousMagneticMaterial.h
-//! @brief     Declares class HomogeneousMagneticMaterial
+//! @brief     Defines class HomogeneousMagneticMaterial
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef HOMOGENEOUSMAGNETICMATERIAL_H
 #define HOMOGENEOUSMAGNETICMATERIAL_H
 
-#include "HomogeneousMaterial.h" // inheriting from
+#include "HomogeneousMaterial.h"
 
 //! @class HomogeneousMagneticMaterial
 //! @ingroup materials
diff --git a/Core/Material/HomogeneousMaterial.h b/Core/Material/HomogeneousMaterial.h
index 7d5935d0528b405a229a77ff9d8159037115586c..34dde203270ad2ac19a7fae3a6fd643e666e2c5a 100644
--- a/Core/Material/HomogeneousMaterial.h
+++ b/Core/Material/HomogeneousMaterial.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Material/HomogeneousMaterial.h
-//! @brief     Declares and implements class HomogeneousMaterial.
+//! @brief     Defines and implements class HomogeneousMaterial.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef HOMOGENEOUSMATERIAL_H
 #define HOMOGENEOUSMATERIAL_H
 
-#include "IMaterial.h" // inheriting from
+#include "IMaterial.h"
 #include <vector>
 
 //! @class HomogeneousMaterial
diff --git a/Core/Material/IMaterial.h b/Core/Material/IMaterial.h
index c212f4e69f96b0504589db4bd4d2ad7b370cc8cc..ce5a5658d1b8b40ff5a40d1e48006fc33403df9e 100644
--- a/Core/Material/IMaterial.h
+++ b/Core/Material/IMaterial.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Material/IMaterial.h
-//! @brief     Declares interface class IMaterial.
+//! @brief     Defines interface class IMaterial.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef IMATERIAL_H
 #define IMATERIAL_H
 
-#include "INamed.h" // inheriting from
+#include "INamed.h"
 #include "Complex.h"
 #include "Vectors3D.h"
 #include "EigenCore.h"
diff --git a/Core/Material/Materials.h b/Core/Material/Materials.h
index 69c4402efe4520188af67087746a9d4d440ef18f..f2c88773264ef2e892b3e126979550042dc948e4 100644
--- a/Core/Material/Materials.h
+++ b/Core/Material/Materials.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Material/Materials.h
-//! @brief     Declares namespace Materials
+//! @brief     Defines namespace Materials
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Multilayer/FormFactorInfo.h b/Core/Multilayer/FormFactorInfo.h
index 0f8b450c91316108e9a9a5dee7593ee9be65f138..a5d37618e6021452b371839420318cae21e631b6 100644
--- a/Core/Multilayer/FormFactorInfo.h
+++ b/Core/Multilayer/FormFactorInfo.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Multilayer/FormFactorInfo.h
-//! @brief     Declares class FormFactorInfo.
+//! @brief     Defines class FormFactorInfo.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef FORMFACTORINFO_H
 #define FORMFACTORINFO_H
 
-#include "ICloneable.h" // inheriting from
+#include "ICloneable.h"
 
 //! @class FormFactorInfo
 //! @ingroup formfactors_internal
diff --git a/Core/Multilayer/IFormFactor.h b/Core/Multilayer/IFormFactor.h
index dfcecbda0faf094db1a278e883554bdc0d76fa58..4136b413fbc8c43894ccd76e49b8a743d84195d6 100644
--- a/Core/Multilayer/IFormFactor.h
+++ b/Core/Multilayer/IFormFactor.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Multilayer/IFormFactor.h
-//! @brief     Declares and implements pure virtual interface IFormFactor.
+//! @brief     Defines and implements pure virtual interface IFormFactor.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef IFORMFACTOR_H
 #define IFORMFACTOR_H
 
-#include "ISample.h" // inheriting from
+#include "ISample.h"
 #include "Complex.h"
 #include "EigenCore.h"
 
diff --git a/Core/Multilayer/ILayerRTCoefficients.h b/Core/Multilayer/ILayerRTCoefficients.h
index aab0e82363481bc77a93ad99dc6b8fa6574ac1ba..8a6964ce9872309887759468009940d8b74858d2 100644
--- a/Core/Multilayer/ILayerRTCoefficients.h
+++ b/Core/Multilayer/ILayerRTCoefficients.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Multilayer/ILayerRTCoefficients.h
-//! @brief     Declares class ILayerRTCoefficients.
+//! @brief     Defines class ILayerRTCoefficients.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Multilayer/IRoughness.h b/Core/Multilayer/IRoughness.h
index 5bb5bc99d65c8eef27a60c810f087c810b7b9151..054498dc5a75c0f28a92ac978518a003a699e6ad 100644
--- a/Core/Multilayer/IRoughness.h
+++ b/Core/Multilayer/IRoughness.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Multilayer/IRoughness.h
-//! @brief     Declares interface class IRoughness.
+//! @brief     Defines interface class IRoughness.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef IROUGHNESS_H
 #define IROUGHNESS_H
 
-#include "ISample.h" // inheriting from
+#include "ISample.h"
 
 //! @class IRoughness
 //! @ingroup samples_internal
diff --git a/Core/Multilayer/ISampleBuilder.h b/Core/Multilayer/ISampleBuilder.h
index 40589ce6c2772387e4ef5bfeaf483c85d6c72767..3b0062fd0bae2e5c18e13fd5d8bdd3b5ba3ee4b3 100644
--- a/Core/Multilayer/ISampleBuilder.h
+++ b/Core/Multilayer/ISampleBuilder.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Multilayer/ISampleBuilder.h
-//! @brief     Declares pure virtual base class ISampleBuilder.
+//! @brief     Defines pure virtual base class ISampleBuilder.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef ISAMPLEBUILDER_H
 #define ISAMPLEBUILDER_H
 
-#include "IParameterized.h" // inheriting from
+#include "IParameterized.h"
 
 class ISample;
 class IFormFactor;
diff --git a/Core/Multilayer/ISpecularInfoMap.h b/Core/Multilayer/ISpecularInfoMap.h
index 38b2a686f7a6c2c66aa716b479c34c8c9c9f5e66..b764413d65709e52671a83083aa3be5da4dd2c9b 100644
--- a/Core/Multilayer/ISpecularInfoMap.h
+++ b/Core/Multilayer/ISpecularInfoMap.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Multilayer/ISpecularInfoMap.h
-//! @brief     Declares interface ISpecularInfoMap.
+//! @brief     Defines interface ISpecularInfoMap.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Multilayer/Layer.h b/Core/Multilayer/Layer.h
index 94a5b2e0645ada0d6a1cd081c8b0fc0667817c71..a380ab2b29cb4136a74efdc99449214709c112e2 100644
--- a/Core/Multilayer/Layer.h
+++ b/Core/Multilayer/Layer.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Multilayer/Layer.h
-//! @brief     Declares class Layer.
+//! @brief     Defines class Layer.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef LAYER_H
 #define LAYER_H
 
-#include "ICompositeSample.h" // inheriting from
+#include "ICompositeSample.h"
 #include "Complex.h"
 #include "SafePointerVector.h"
 
diff --git a/Core/Multilayer/LayerInterface.h b/Core/Multilayer/LayerInterface.h
index df6d817a4e00b79799dca8aab7009a361628f12b..d696b599899a17e9668bdbdd3c39d6ce5c04229f 100644
--- a/Core/Multilayer/LayerInterface.h
+++ b/Core/Multilayer/LayerInterface.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Multilayer/LayerInterface.h
-//! @brief     Declares class LayerInterface.
+//! @brief     Defines class LayerInterface.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef LAYERINTERFACE_H
 #define LAYERINTERFACE_H
 
-#include "ICompositeSample.h" // inheriting from
+#include "ICompositeSample.h"
 #include "LayerRoughness.h"
 
 
diff --git a/Core/Multilayer/LayerRoughness.cpp b/Core/Multilayer/LayerRoughness.cpp
index 7498cfd702a2c082324965ce66bf03a9dc04afdb..997b2e32e8f13fc5f78d20411229b1d1fa6a0b3b 100644
--- a/Core/Multilayer/LayerRoughness.cpp
+++ b/Core/Multilayer/LayerRoughness.cpp
@@ -16,7 +16,7 @@
 #include "LayerRoughness.h"
 #include "BornAgainNamespace.h"
 #include "ISampleVisitor.h"
-#include "Units.h"
+#include "Pi.h"
 
 LayerRoughness::LayerRoughness()
     : m_sigma(0)
@@ -56,7 +56,7 @@ double LayerRoughness::getSpectralFun(const kvector_t kvec) const
     double H = m_hurstParameter;
     double clength2 = m_latteralCorrLength*m_latteralCorrLength;
     double Qpar2 = kvec.x()*kvec.x() + kvec.y()*kvec.y();
-    return 4.0*Units::PI*H * m_sigma*m_sigma * clength2 *
+    return 4.0*Pi::PI*H * m_sigma*m_sigma * clength2 *
         std::pow( (1.0 + Qpar2*clength2), (-1-H) );
 }
 
diff --git a/Core/Multilayer/LayerRoughness.h b/Core/Multilayer/LayerRoughness.h
index dfc9dc4821497a438b59b86d17f091742b2f5276..a45af6d8796d3f84578daee65e8c0428128182ab 100644
--- a/Core/Multilayer/LayerRoughness.h
+++ b/Core/Multilayer/LayerRoughness.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Multilayer/LayerRoughness.h
-//! @brief     Declares class LayerRoughness.
+//! @brief     Defines class LayerRoughness.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef LAYERROUGHNESS_H
 #define LAYERROUGHNESS_H
 
-#include "IRoughness.h" // inheriting from
+#include "IRoughness.h"
 #include "Vectors3D.h"
 
 //! @class LayerRoughness
diff --git a/Core/Multilayer/LayerSpecularInfo.h b/Core/Multilayer/LayerSpecularInfo.h
index 470f9f39e6fe9a27cd620a53dcc1011b4dd8f4bb..93ac30aafe69d25d4ec8201296883824c0c477e8 100644
--- a/Core/Multilayer/LayerSpecularInfo.h
+++ b/Core/Multilayer/LayerSpecularInfo.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Multilayer/LayerSpecularInfo.h
-//! @brief     Declares class LayerSpecularInfo.
+//! @brief     Defines class LayerSpecularInfo.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef LAYERSPECULARINFO_H
 #define LAYERSPECULARINFO_H
 
-#include "ICloneable.h" // inheriting from
+#include "ICloneable.h"
 #include <memory>
 
 class ISpecularInfoMap;
diff --git a/Core/Multilayer/LayerStrategyBuilder.h b/Core/Multilayer/LayerStrategyBuilder.h
index 61919ee75ed7a8828099caa0f65a4c718c894645..16707686296019e20e1abe5b8d2693112b1bbbed 100644
--- a/Core/Multilayer/LayerStrategyBuilder.h
+++ b/Core/Multilayer/LayerStrategyBuilder.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Multilayer/LayerStrategyBuilder.h
-//! @brief     Declares class LayerStrategyBuilder.
+//! @brief     Defines class LayerStrategyBuilder.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Multilayer/MatrixRTCoefficients.h b/Core/Multilayer/MatrixRTCoefficients.h
index eafb8ca617f36d29e34768bc14a9bad782b8873c..18af989e3d466b9c6250712e26d42ea91d4cc047 100644
--- a/Core/Multilayer/MatrixRTCoefficients.h
+++ b/Core/Multilayer/MatrixRTCoefficients.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Multilayer/MatrixRTCoefficients.h
-//! @brief     Declares class MatrixRTCoefficients.
+//! @brief     Defines class MatrixRTCoefficients.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef MATRIXRTCOEFFICIENTS_H
 #define MATRIXRTCOEFFICIENTS_H
 
-#include "ILayerRTCoefficients.h" // inheriting from
+#include "ILayerRTCoefficients.h"
 
 
 //! @class MatrixRTCoefficients
diff --git a/Core/Multilayer/MatrixSpecularInfoMap.h b/Core/Multilayer/MatrixSpecularInfoMap.h
index f4af52b55a6b434c6d6de8ea20e4a24611eac894..f561d8dd75bd579fdab236e30eec0a1dc62cab44 100644
--- a/Core/Multilayer/MatrixSpecularInfoMap.h
+++ b/Core/Multilayer/MatrixSpecularInfoMap.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Multilayer/MatrixSpecularInfoMap.h
-//! @brief     Declares class MatrixSpecularInfoMap.
+//! @brief     Defines class MatrixSpecularInfoMap.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef MATRIXSPECULARINFOMAP_H
 #define MATRIXSPECULARINFOMAP_H
 
-#include "ISpecularInfoMap.h" // inheriting from
+#include "ISpecularInfoMap.h"
 #include "MatrixRTCoefficients.h"
 #include <memory>
 
diff --git a/Core/Multilayer/MultiLayer.h b/Core/Multilayer/MultiLayer.h
index 5b5c57f4f39d32f02d7e30b81b5fae4c67264043..cc76849a8a814fd4a85d90c1d4444390c81ad229 100644
--- a/Core/Multilayer/MultiLayer.h
+++ b/Core/Multilayer/MultiLayer.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Multilayer/MultiLayer.h
-//! @brief     Declares class MultiLayer.
+//! @brief     Defines class MultiLayer.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef MULTILAYER_H
 #define MULTILAYER_H
 
-#include "ICompositeSample.h" // inheriting from
+#include "ICompositeSample.h"
 #include "Vectors3D.h"
 
 class GISASSimulation;
diff --git a/Core/Multilayer/ScalarRTCoefficients.h b/Core/Multilayer/ScalarRTCoefficients.h
index bafe0236f65bcb576992b8b69ccb395c42d9d81d..aa1a3199d32478904756f9f5a4b923c955fed2f6 100644
--- a/Core/Multilayer/ScalarRTCoefficients.h
+++ b/Core/Multilayer/ScalarRTCoefficients.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Multilayer/ScalarRTCoefficients.h
-//! @brief     Declares class ScalarRTCoefficients.
+//! @brief     Defines class ScalarRTCoefficients.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef SCALARRTCOEFFICIENTS_H
 #define SCALARRTCOEFFICIENTS_H
 
-#include "ILayerRTCoefficients.h" // inheriting from
+#include "ILayerRTCoefficients.h"
 #include "Complex.h"
 #include "EigenCore.h"
 
diff --git a/Core/Multilayer/ScalarSpecularInfoMap.h b/Core/Multilayer/ScalarSpecularInfoMap.h
index 00770afd66c86ca7e701493dcaaa0e23407a3dae..2ce3f608ef5670d967d9a1c98e673de609f5db7f 100644
--- a/Core/Multilayer/ScalarSpecularInfoMap.h
+++ b/Core/Multilayer/ScalarSpecularInfoMap.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Multilayer/ScalarSpecularInfoMap.h
-//! @brief     Declares class ScalarSpecularInfoMap.
+//! @brief     Defines class ScalarSpecularInfoMap.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef SCALARSPECULARINFOMAP_H
 #define SCALARSPECULARINFOMAP_H
 
-#include "ISpecularInfoMap.h" // inheriting from
+#include "ISpecularInfoMap.h"
 #include "Vectors3D.h"
 
 class MultiLayer;
diff --git a/Core/Multilayer/SpecularMagnetic.h b/Core/Multilayer/SpecularMagnetic.h
index 6313f1bba32c1443a8616ccc99105512886f61f7..5155d6c1eb86995471b3c4a00c54a9092e37edf3 100644
--- a/Core/Multilayer/SpecularMagnetic.h
+++ b/Core/Multilayer/SpecularMagnetic.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Multilayer/SpecularMagnetic.h
-//! @brief     Declares class SpecularMagnetic.
+//! @brief     Defines class SpecularMagnetic.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef SPECULARMAGNETIC_H
 #define SPECULARMAGNETIC_H
 
-#include "ISimulation.h" // inheriting from
+#include "ISimulation.h"
 #include "MatrixRTCoefficients.h"
 #include "Vectors3D.h"
 #include <vector>
diff --git a/Core/Multilayer/SpecularMatrix.cpp b/Core/Multilayer/SpecularMatrix.cpp
index 927c170271b5bc75501659f26984e772453e2e4b..4f23bf66490ecaf96ff2cdfefa7a7f9665b4eaf8 100644
--- a/Core/Multilayer/SpecularMatrix.cpp
+++ b/Core/Multilayer/SpecularMatrix.cpp
@@ -18,7 +18,7 @@
 #include "LayerInterface.h"
 #include "MathFunctions.h"
 #include "MultiLayer.h"
-#include "Units.h"
+#include "Pi.h"
 
 namespace {
     const complex_t imag_unit = complex_t(0.0, 1.0);
@@ -110,7 +110,7 @@ bool calculateUpFromLayer(SpecularMatrix::MultiLayerCoeff_t& coeff, const MultiL
             if(sigma > 0.0) {
                 // since there is a roughness, compute one diagonal matrix element p00;
                 // the other element is p11 = 1/p00.
-                double sigeff = std::pow(Units::PID2, 1.5)*sigma*k.mag();
+                double sigeff = std::pow(Pi::PID2, 1.5)*sigma*k.mag();
                 roughness_factor = sqrt(
                             MathFunctions::tanhc(sigeff*coeff[i+1].lambda) /
                             MathFunctions::tanhc(sigeff*coeff[i  ].lambda) );
diff --git a/Core/Multilayer/SpecularMatrix.h b/Core/Multilayer/SpecularMatrix.h
index c0c548c0dfb5948310730fdb6211518717849a03..34273513e1853a0065cd3d2b7e95594f27f01999 100644
--- a/Core/Multilayer/SpecularMatrix.h
+++ b/Core/Multilayer/SpecularMatrix.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Multilayer/SpecularMatrix.h
-//! @brief     Declares class SpecularMatrix.
+//! @brief     Defines class SpecularMatrix.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef SPECULARMATRIX_H
 #define SPECULARMATRIX_H
 
-#include "ISimulation.h" // inheriting from
+#include "ISimulation.h"
 #include "ScalarRTCoefficients.h"
 #include "Vectors3D.h"
 #include <vector>
diff --git a/Core/Parametrization/DimensionedParameters.h b/Core/Parametrization/DimensionedParameters.h
index 84f5d48723a5d2c6e17a3bc56da1b6f9b75d8eb2..c9ca7834902ffc1a8730596ef51f7f5ba84d38e4 100644
--- a/Core/Parametrization/DimensionedParameters.h
+++ b/Core/Parametrization/DimensionedParameters.h
@@ -16,7 +16,7 @@
 #ifndef DIMENSIONEDPARAMETERS_H
 #define DIMENSIONEDPARAMETERS_H
 
-#include "RealParameter.h" // inheriting from
+#include "RealParameter.h"
 
 //! A parameter of physical dimension "angle".
 
diff --git a/Core/Parametrization/Distributions.cpp b/Core/Parametrization/Distributions.cpp
index 9267d09695b964636f265bb167ed05d054ab8233..ba1f3c00de68cd2abdd878ef7543db076a9a6118 100644
--- a/Core/Parametrization/Distributions.cpp
+++ b/Core/Parametrization/Distributions.cpp
@@ -17,7 +17,7 @@
 #include "BornAgainNamespace.h"
 #include "Exceptions.h"
 #include "MathFunctions.h"
-#include "Units.h"
+#include "Pi.h"
 
 using namespace BornAgain;
 
@@ -187,7 +187,7 @@ DistributionLorentz::DistributionLorentz(double mean, double hwhm) : m_mean(mean
 double DistributionLorentz::probabilityDensity(double x) const
 {
     if (m_hwhm == 0.0) return x==m_mean ? 1.0 : 0.0;
-    return m_hwhm/(m_hwhm*m_hwhm + (x-m_mean)*(x-m_mean))/Units::PI;
+    return m_hwhm/(m_hwhm*m_hwhm + (x-m_mean)*(x-m_mean))/Pi::PI;
 }
 
 std::vector<double> DistributionLorentz::generateValueList(size_t nbr_samples,
@@ -244,7 +244,7 @@ double DistributionGaussian::probabilityDensity(double x) const
     if (m_std_dev == 0.0) return x==m_mean ? 1.0 : 0.0;
     double exponential = std::exp(-(x-m_mean)*(x-m_mean)
             /(2.0*m_std_dev*m_std_dev));
-    return exponential/m_std_dev/std::sqrt(Units::PI2);
+    return exponential/m_std_dev/std::sqrt(Pi::PI2);
 }
 
 std::vector<double> DistributionGaussian::generateValueList(size_t nbr_samples,
@@ -300,7 +300,7 @@ double DistributionLogNormal::probabilityDensity(double x) const
 {
     if (m_scale_param==0.0) return x==m_median ? 1.0 : 0.0;
     double t = std::log(x/m_median)/m_scale_param;
-    return std::exp(-t*t/2.0)/(x*m_scale_param*std::sqrt(Units::PI2));
+    return std::exp(-t*t/2.0)/(x*m_scale_param*std::sqrt(Pi::PI2));
 }
 
 double DistributionLogNormal::getMean() const
@@ -368,16 +368,16 @@ DistributionCosine::DistributionCosine(double mean, double sigma)
 double DistributionCosine::probabilityDensity(double x) const
 {
     if (m_sigma == 0.0) return x==m_mean ? 1.0 : 0.0;
-    if (std::abs(x-m_mean)>Units::PI*m_sigma) return 0.0;
-    return (1.0 + std::cos((x-m_mean)/m_sigma))/(m_sigma*Units::PI2);
+    if (std::abs(x-m_mean)>Pi::PI*m_sigma) return 0.0;
+    return (1.0 + std::cos((x-m_mean)/m_sigma))/(m_sigma*Pi::PI2);
 }
 
 std::vector<double> DistributionCosine::generateValueList(size_t nbr_samples,
         double sigma_factor, const AttLimits &limits) const
 {
     if (sigma_factor <= 0.0 || sigma_factor > 2.0) sigma_factor = 2.0;
-    double xmin = m_mean - sigma_factor*m_sigma*Units::PID2;
-    double xmax = m_mean + sigma_factor*m_sigma*Units::PID2;
+    double xmin = m_mean - sigma_factor*m_sigma*Pi::PID2;
+    double xmax = m_mean + sigma_factor*m_sigma*Pi::PID2;
     adjustMinMaxForLimits(xmin, xmax, limits);
     return generateValues(nbr_samples, xmin, xmax);
 }
diff --git a/Core/Parametrization/Distributions.h b/Core/Parametrization/Distributions.h
index bdfc47d7ac019f9a727e15c01c8a20e8dd402adb..db13667aedcd03611518e970c82180967c242f23 100644
--- a/Core/Parametrization/Distributions.h
+++ b/Core/Parametrization/Distributions.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Parametrization/Distributions.h
-//! @brief     Declares classes representing distributions.
+//! @brief     Defines classes representing distributions.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef DISTRIBUTIONS_H
 #define DISTRIBUTIONS_H
 
-#include "IParameterized.h" // inheriting from
+#include "IParameterized.h"
 #include "AttLimits.h"
 #include "ParameterSample.h"
 #include <vector>
diff --git a/Core/Parametrization/FitParameterLinked.h b/Core/Parametrization/FitParameterLinked.h
index 6208d2eccc096344e7168bc7edc21e84b6bfd685..f39ec43925e53e670ebf9f6d7b843796579d50e8 100644
--- a/Core/Parametrization/FitParameterLinked.h
+++ b/Core/Parametrization/FitParameterLinked.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Parametrization/FitParameterLinked.h
-//! @brief     Declares class FitParameterLinked.
+//! @brief     Defines class FitParameterLinked.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef FITPARAMETERLINKED_H
 #define FITPARAMETERLINKED_H
 
-#include "FitParameter.h" // inheriting from
+#include "FitParameter.h"
 #include <vector>
 
 class ParameterPool;
diff --git a/Core/Parametrization/INamed.h b/Core/Parametrization/INamed.h
index b255df9a28d603fb6818c362288879171085b50e..36a5d48d2416086b3e5bf68c6a8b9fe1f3d7ecfc 100644
--- a/Core/Parametrization/INamed.h
+++ b/Core/Parametrization/INamed.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Parametrization/INamed.h
-//! @brief     Declares and implements the standard mix-in INamed.
+//! @brief     Defines and implements the standard mix-in INamed.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Parametrization/IParameterized.h b/Core/Parametrization/IParameterized.h
index f3ad7c8eb01231a5b2375fb8a4b48bfd17c222dd..1620458224e2f4c3b142083c4157f8cf73663213 100644
--- a/Core/Parametrization/IParameterized.h
+++ b/Core/Parametrization/IParameterized.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Parametrization/IParameterized.h
-//! @brief     Declares class IParameterized.
+//! @brief     Defines class IParameterized.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef IPARAMETERIZED_H
 #define IPARAMETERIZED_H
 
-#include "INamed.h" // inheriting from
+#include "INamed.h"
 
 class AttLimits;
 class ParameterPool;
diff --git a/Core/Parametrization/ParameterDistribution.h b/Core/Parametrization/ParameterDistribution.h
index a5f97cf9a5e9abd3cd4df830c05f9553431c4c5f..5e7b06788dbc636c1ff9aaf4cc6bb54db1578cc0 100644
--- a/Core/Parametrization/ParameterDistribution.h
+++ b/Core/Parametrization/ParameterDistribution.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Parametrization/ParameterDistribution.h
-//! @brief     Declares class ParameterDistribution.
+//! @brief     Defines class ParameterDistribution.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef PARAMETERDISTRIBUTION_H
 #define PARAMETERDISTRIBUTION_H
 
-#include "IParameterized.h" // inheriting from
+#include "IParameterized.h"
 #include "AttLimits.h"
 #include "ParameterSample.h"
 #include <memory>
diff --git a/Core/Parametrization/ParameterPattern.h b/Core/Parametrization/ParameterPattern.h
index abf231fe4ab48da8a2909e08f8d7b903d2f8d8b5..7e66775cfb4dffac626bd35c968f1e2b710a4f85 100644
--- a/Core/Parametrization/ParameterPattern.h
+++ b/Core/Parametrization/ParameterPattern.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Parametrization/ParameterPattern.h
-//! @brief     Declares class ParameterPattern
+//! @brief     Defines class ParameterPattern
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Parametrization/ParameterPool.h b/Core/Parametrization/ParameterPool.h
index dba5bec0592a55e035ad111c5a19ca2148011a3a..8f4250e49973d1e70d20c0cf0a53d2f9bd12cd83 100644
--- a/Core/Parametrization/ParameterPool.h
+++ b/Core/Parametrization/ParameterPool.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Parametrization/ParameterPool.h
-//! @brief     Declares class ParameterPool.
+//! @brief     Defines class ParameterPool.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Parametrization/ParameterSample.h b/Core/Parametrization/ParameterSample.h
index d8b87a7828fcfcfd5a684f2a8a836aea175c00f9..5357fba3b6633e40717d948bcddee3aff6a40485 100644
--- a/Core/Parametrization/ParameterSample.h
+++ b/Core/Parametrization/ParameterSample.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Parametrization/ParameterSample.h
-//! @brief     Declares class ParameterSample.
+//! @brief     Defines class ParameterSample.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Parametrization/RealParameter.h b/Core/Parametrization/RealParameter.h
index fa8b959c3edb3b91f4119724060ebcd16daa1a1a..8b1d416a9be95c677d7ed2329c3397b4d2968901 100644
--- a/Core/Parametrization/RealParameter.h
+++ b/Core/Parametrization/RealParameter.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Parametrization/RealParameter.h
-//! @brief     Declares class RealParameter.
+//! @brief     Defines class RealParameter.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef REALPARAMETER_H
 #define REALPARAMETER_H
 
-#include "INamed.h" // inheriting from
+#include "INamed.h"
 #include "AttLimits.h"
 #include <string>
 
diff --git a/Core/Parametrization/SimulationOptions.h b/Core/Parametrization/SimulationOptions.h
index d47a8a51504bbcf37ec97480a05a1f35419d2db9..0708aca288ee21c30baeccff56c1aec99e77f16b 100644
--- a/Core/Parametrization/SimulationOptions.h
+++ b/Core/Parametrization/SimulationOptions.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Parametrization/SimulationOptions.h
-//! @brief     Declares class SimulationOptions.
+//! @brief     Defines class SimulationOptions.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Parametrization/ThreadInfo.h b/Core/Parametrization/ThreadInfo.h
index ab1e263d490c1818d84e140efecebb8b6533f955..7ad959518a875ed94e30465f6c4cba0d6ec3346b 100644
--- a/Core/Parametrization/ThreadInfo.h
+++ b/Core/Parametrization/ThreadInfo.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Parametrization/ThreadInfo.h
-//! @brief     Declares struct ThreadInfo.
+//! @brief     Defines struct ThreadInfo.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Particle/Crystal.h b/Core/Particle/Crystal.h
index d99a22c8fcd12946364e707a36d0939e5fffab4e..4b42bd5a677860cb2016005a8b3e1992ffa06b01 100644
--- a/Core/Particle/Crystal.h
+++ b/Core/Particle/Crystal.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Particle/Crystal.h
-//! @brief     Declares class Crystal.
+//! @brief     Defines class Crystal.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef CRYSTAL_H
 #define CRYSTAL_H
 
-#include "IClusteredParticles.h" // inheriting from
+#include "IClusteredParticles.h"
 #include "Lattice.h"
 #include "Particle.h"
 #include "ParticleComposition.h"
diff --git a/Core/Particle/FormFactorCrystal.cpp b/Core/Particle/FormFactorCrystal.cpp
index 83f674825efc1bc16bef968d3b29b368cc7a8996..aa0a5f295bff02ae334b342e624a6d1ae8779967 100644
--- a/Core/Particle/FormFactorCrystal.cpp
+++ b/Core/Particle/FormFactorCrystal.cpp
@@ -16,7 +16,7 @@
 #include "FormFactorCrystal.h"
 #include "BornAgainNamespace.h"
 #include "Exceptions.h"
-#include "Units.h"
+#include "Pi.h"
 #include "WavevectorInfo.h"
 
 FormFactorCrystal::FormFactorCrystal(const Lattice& lattice, const IFormFactor& basis_form_factor,
@@ -124,6 +124,6 @@ void FormFactorCrystal::calculateLargestReciprocalDistance()
     kvector_t a2 = m_lattice.getBasisVectorB();
     kvector_t a3 = m_lattice.getBasisVectorC();
 
-    m_max_rec_length = std::max(Units::PI / a1.mag(), Units::PI / a2.mag());
-    m_max_rec_length = std::max(m_max_rec_length, Units::PI / a3.mag());
+    m_max_rec_length = std::max(Pi::PI / a1.mag(), Pi::PI / a2.mag());
+    m_max_rec_length = std::max(m_max_rec_length, Pi::PI / a3.mag());
 }
diff --git a/Core/Particle/FormFactorCrystal.h b/Core/Particle/FormFactorCrystal.h
index ba50b442601459cf2b78c724e8cdebb75e2f3652..21380b691a0cf0cd49c90985c247ef6bfabbbbd6 100644
--- a/Core/Particle/FormFactorCrystal.h
+++ b/Core/Particle/FormFactorCrystal.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Particle/FormFactorCrystal.h
-//! @brief     Declares class FormFactorCrystal.
+//! @brief     Defines class FormFactorCrystal.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef FORMFACTORCRYSTAL_H
 #define FORMFACTORCRYSTAL_H
 
-#include "IFormFactorBorn.h" // inheriting from
+#include "IFormFactorBorn.h"
 #include "Lattice.h"
 
 //! @class FormFactorCrystal
diff --git a/Core/Particle/FormFactorWeighted.h b/Core/Particle/FormFactorWeighted.h
index cbb150c430efb2d87575ce40b439ab1ba748a918..0d5a9699cc6b4fc2db39cfa0b3836e03c8e33d16 100644
--- a/Core/Particle/FormFactorWeighted.h
+++ b/Core/Particle/FormFactorWeighted.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Particle/FormFactorWeighted.h
-//! @brief     Declares class FormFactorWeighted.
+//! @brief     Defines class FormFactorWeighted.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef FORMFACTORWEIGHTED_H
 #define FORMFACTORWEIGHTED_H
 
-#include "IFormFactor.h" // inheriting from
+#include "IFormFactor.h"
 
 //! @class FormFactorWeighted
 //! @ingroup formfactors_internal
diff --git a/Core/Particle/IClusteredParticles.h b/Core/Particle/IClusteredParticles.h
index 591f7bd679dd2961d3eefdff66b9bda022db82fa..cc59b6c7299064316cf1be6aba4392598793fd85 100644
--- a/Core/Particle/IClusteredParticles.h
+++ b/Core/Particle/IClusteredParticles.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Particle/IClusteredParticles.h
-//! @brief     Declares class IClusteredParticles.
+//! @brief     Defines class IClusteredParticles.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef ICLUSTEREDPARTICLES_H
 #define ICLUSTEREDPARTICLES_H
 
-#include "ICompositeSample.h" // inheriting from
+#include "ICompositeSample.h"
 #include "IFormFactor.h"
 #include "Vectors3D.h"
 
diff --git a/Core/Particle/IFormFactorBorn.h b/Core/Particle/IFormFactorBorn.h
index 7d58c09e8e722465afa4c1446c15cc5fea10a851..d1e321009f6074775289918202b7cf78016d1641 100644
--- a/Core/Particle/IFormFactorBorn.h
+++ b/Core/Particle/IFormFactorBorn.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Particle/IFormFactorBorn.h
-//! @brief     Declares pure virtual interface class IFormFactorBorn.
+//! @brief     Defines pure virtual interface class IFormFactorBorn.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef IFORMFACTORBORN_H
 #define IFORMFACTORBORN_H
 
-#include "IFormFactor.h" // inheriting from
+#include "IFormFactor.h"
 #include "Vectors3D.h"
 
 //! @class IFormFactorBorn
diff --git a/Core/Particle/IParticle.h b/Core/Particle/IParticle.h
index 788ce32adbc44f0ed880d8a0748efb62ac6c3c54..1621a4b01fe15abf010bb9ffec77b17b5ff13f44 100644
--- a/Core/Particle/IParticle.h
+++ b/Core/Particle/IParticle.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Particle/IParticle.h
-//! @brief     Declares interface IParticle.
+//! @brief     Defines interface IParticle.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef IPARTICLE_H
 #define IPARTICLE_H
 
-#include "ICompositeSample.h" // inheriting from
+#include "ICompositeSample.h"
 #include "Rotations.h"
 #include "Vectors3D.h"
 #include <memory>
diff --git a/Core/Particle/MesoCrystal.h b/Core/Particle/MesoCrystal.h
index f6ba223c9426eaffe02006c959c1fe2274e5aa3e..12391579c6fb9343887acaf3b0556f15b3a42a69 100644
--- a/Core/Particle/MesoCrystal.h
+++ b/Core/Particle/MesoCrystal.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Particle/MesoCrystal.h
-//! @brief     Declares class MesoCrystal.
+//! @brief     Defines class MesoCrystal.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef MESOCRYSTAL_H
 #define MESOCRYSTAL_H
 
-#include "IParticle.h" // inheriting from
+#include "IParticle.h"
 
 class IClusteredParticles;
 class IMaterial;
diff --git a/Core/Particle/Particle.h b/Core/Particle/Particle.h
index a1b859018272424aa79b1d16bf94dfd858e44fce..98a21c02ff84cdd76d67730b4c802342f0e6149b 100644
--- a/Core/Particle/Particle.h
+++ b/Core/Particle/Particle.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Particle/Particle.h
-//! @brief     Declares class Particle.
+//! @brief     Defines class Particle.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef PARTICLE_H
 #define PARTICLE_H
 
-#include "IParticle.h" // inheriting from
+#include "IParticle.h"
 #include "IMaterial.h"
 #include "FormFactorDecoratorMaterial.h"
 #include "FormFactorDecoratorRotation.h"
diff --git a/Core/Particle/ParticleComposition.h b/Core/Particle/ParticleComposition.h
index 4a76823dff772bbdcb7b029bacf000962c3b46a9..c70b2cdae1ecae06f00d356ce3e0ade8a86ec395 100644
--- a/Core/Particle/ParticleComposition.h
+++ b/Core/Particle/ParticleComposition.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Particle/ParticleComposition.h
-//! @brief     Declares class ParticleComposition.
+//! @brief     Defines class ParticleComposition.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef PARTICLECOMPOSITION_H
 #define PARTICLECOMPOSITION_H
 
-#include "IParticle.h" // inheriting from
+#include "IParticle.h"
 
 class IMaterial;
 
diff --git a/Core/Particle/ParticleCoreShell.h b/Core/Particle/ParticleCoreShell.h
index fafb7195ebb685851ddbef037ebbaa8b049595e1..89d71032617a7c0712204e4638964e8bf21f8fe5 100644
--- a/Core/Particle/ParticleCoreShell.h
+++ b/Core/Particle/ParticleCoreShell.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Particle/ParticleCoreShell.h
-//! @brief     Declares ParticleCoreShell.
+//! @brief     Defines ParticleCoreShell.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef PARTICLECORESHELL_H
 #define PARTICLECORESHELL_H
 
-#include "IParticle.h" // inheriting from
+#include "IParticle.h"
 
 class IMaterial;
 class Particle;
diff --git a/Core/Particle/ParticleDistribution.h b/Core/Particle/ParticleDistribution.h
index 2eb534ff04a824a3585b0965196ec0b19839de2e..c1032a71a57e16d149af41958fc224283159b77a 100644
--- a/Core/Particle/ParticleDistribution.h
+++ b/Core/Particle/ParticleDistribution.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Particle/ParticleDistribution.h
-//! @brief     Declares class ParticleDistribution.
+//! @brief     Defines class ParticleDistribution.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Particle/TRange.h b/Core/Particle/TRange.h
index b82ea453f4b7fb8a6fa99e0850408984cf13e4bd..31a2f1de8b1567532722de6c5721b41e80ccac52 100644
--- a/Core/Particle/TRange.h
+++ b/Core/Particle/TRange.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Particle/TRange.h
-//! @brief     Declares and implements template classes TRange and TSampledRange.
+//! @brief     Defines and implements template classes TRange and TSampledRange.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Rotation/Rotations.h b/Core/Rotation/Rotations.h
index 439884806f225ba270ba9684a929339cc0ab6636..885d90651dc09a0f0b961a68e97d7f34910debe3 100644
--- a/Core/Rotation/Rotations.h
+++ b/Core/Rotation/Rotations.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Rotation/Rotations.h
-//! @brief     Declares IRotation classes.
+//! @brief     Defines IRotation classes.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef ROTATIONS_H
 #define ROTATIONS_H
 
-#include "ISample.h" // inheriting from
+#include "ISample.h"
 #include "Transform3D.h"
 
 //! @class IRotation
diff --git a/Core/Sample/ICompositeSample.h b/Core/Sample/ICompositeSample.h
index 60ce56658a9b0ab17f710d397855ab39d73f7f7c..8470abb3aba52ca7eb034360eb48d6fab7628613 100644
--- a/Core/Sample/ICompositeSample.h
+++ b/Core/Sample/ICompositeSample.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Sample/ICompositeSample.h
-//! @brief     Declares interface class ICompositeSample.
+//! @brief     Defines interface class ICompositeSample.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef ICOMPOSITESAMPLE_H
 #define ICOMPOSITESAMPLE_H
 
-#include "ISample.h" // inheriting from
+#include "ISample.h"
 
 class ISampleVisitor;
 
diff --git a/Core/Sample/ISample.h b/Core/Sample/ISample.h
index e7e77f7e1af2c6920a8ad3217aa2ddebf52be70c..4cd3139af0762c77eda075f0c606e224f86f9af1 100644
--- a/Core/Sample/ISample.h
+++ b/Core/Sample/ISample.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Sample/ISample.h
-//! @brief     Declares interface class ISample.
+//! @brief     Defines interface class ISample.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,8 +16,8 @@
 #ifndef ISAMPLE_H
 #define ISAMPLE_H
 
-#include "ICloneable.h" // inheriting from
-#include "IParameterized.h" // inheriting from
+#include "ICloneable.h"
+#include "IParameterized.h"
 #include "ISampleVisitor.h"
 #include <vector>
 
diff --git a/Core/Sample/ISampleIteratorStrategy.h b/Core/Sample/ISampleIteratorStrategy.h
index 41ddce043ca7009607f704b3fb47cc411643836a..9fa9474da0c9b25a88c3e111f42abbc08453d23c 100644
--- a/Core/Sample/ISampleIteratorStrategy.h
+++ b/Core/Sample/ISampleIteratorStrategy.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Sample/ISampleIteratorStrategy.h
-//! @brief     Declares strategies for the class SampleTreeIterator.
+//! @brief     Defines strategies for the class SampleTreeIterator.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef ISAMPLEITERATORSTRATEGY_H
 #define ISAMPLEITERATORSTRATEGY_H
 
-#include "ISample.h" // inheriting from
+#include "ISample.h"
 
 class IteratorMemento;
 
diff --git a/Core/Sample/ISampleVisitor.h b/Core/Sample/ISampleVisitor.h
index 59d8213d175b5fe841f2b34db261212da4036cff..2d3b1f440d1f64884d5f25f3a9ee3698b9ef5563 100644
--- a/Core/Sample/ISampleVisitor.h
+++ b/Core/Sample/ISampleVisitor.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Sample/ISampleVisitor.h
-//! @brief     Declares interface class ISampleVisitor.
+//! @brief     Defines interface class ISampleVisitor.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Sample/SampleTreeIterator.h b/Core/Sample/SampleTreeIterator.h
index 136844d3a8d2828831d831bd27b7c0c675bc5a2a..71211587ec7547594f509d52e2c4ed452c6fe8b2 100644
--- a/Core/Sample/SampleTreeIterator.h
+++ b/Core/Sample/SampleTreeIterator.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Sample/SampleTreeIterator.h
-//! @brief     Declares and classes IteratorState, IteratorMemento and SampleTreeIterator.
+//! @brief     Defines and classes IteratorState, IteratorMemento and SampleTreeIterator.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Simulation/DWBADiffuseReflection.cpp b/Core/Simulation/DWBADiffuseReflection.cpp
index 092e45dae4e00f06d2f3090bea34663fd1e659ec..057c7c4746115f7d29e11226cf56781530ba15ea 100644
--- a/Core/Simulation/DWBADiffuseReflection.cpp
+++ b/Core/Simulation/DWBADiffuseReflection.cpp
@@ -17,7 +17,7 @@
 #include "Layer.h"
 #include "LayerInterface.h"
 #include "MultiLayer.h"
-#include "Units.h"
+#include "Pi.h"
 
 DWBADiffuseReflection::DWBADiffuseReflection()
     : m_sample(0)
@@ -62,7 +62,7 @@ void DWBADiffuseReflection::diffuse_autocorr()
         autocorr += std::norm( get_refractive_term(i)) * std::norm(get_sum4terms(i) ) *
             m_sample->getLayerBottomInterface(i)->getRoughness()->getSpectralFun(m_q);
     }
-    m_diffuse_autocorr = autocorr*m_ki.mag2()/16./Units::PI;
+    m_diffuse_autocorr = autocorr*m_ki.mag2()/16./Pi::PI;
 }
 
 void DWBADiffuseReflection::diffuse_crosscorr()
@@ -86,7 +86,7 @@ void DWBADiffuseReflection::diffuse_crosscorr()
                 std::conj(sterm[k]);
         }
     }
-    m_diffuse_crosscorr = crosscorr.real()*m_ki.mag2()/16./Units::PI;
+    m_diffuse_crosscorr = crosscorr.real()*m_ki.mag2()/16./Pi::PI;
 }
 
 complex_t DWBADiffuseReflection::get_refractive_term(size_t ilayer) const
diff --git a/Core/Simulation/DWBADiffuseReflection.h b/Core/Simulation/DWBADiffuseReflection.h
index d0e5126b0c4483bdd85f6b1f99a6ee3b7721a6ff..74a8cfcab6cdbbaae077b562bf84bb353ae97b36 100644
--- a/Core/Simulation/DWBADiffuseReflection.h
+++ b/Core/Simulation/DWBADiffuseReflection.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Simulation/DWBADiffuseReflection.h
-//! @brief     Declares class DWBADiffuseReflection.
+//! @brief     Defines class DWBADiffuseReflection.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Simulation/DWBASimulation.h b/Core/Simulation/DWBASimulation.h
index ebc50cac9beed92c09b24c2a51c70110842db9b5..d62bda3165a9a24b6a87ba2c4037899b531699d1 100644
--- a/Core/Simulation/DWBASimulation.h
+++ b/Core/Simulation/DWBASimulation.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Simulation/DWBASimulation.h
-//! @brief     Declares class DWBASimulation.
+//! @brief     Defines class DWBASimulation.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef DWBASIMULATION_H
 #define DWBASIMULATION_H
 
-#include "ISimulation.h" // inheriting from
+#include "ISimulation.h"
 #include "GISASSimulation.h"
 #include "ProgressHandlerDWBA.h"
 
diff --git a/Core/Simulation/DecoratedLayerDWBASimulation.h b/Core/Simulation/DecoratedLayerDWBASimulation.h
index 18e6fd06115ec7158604ac571132364aef780699..59bea9033c522ad73d73e704a2fb95186ec479dc 100644
--- a/Core/Simulation/DecoratedLayerDWBASimulation.h
+++ b/Core/Simulation/DecoratedLayerDWBASimulation.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Simulation/DecoratedLayerDWBASimulation.h
-//! @brief     Declares class DecoratedLayerDWBASimulation.
+//! @brief     Defines class DecoratedLayerDWBASimulation.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef DECORATEDLAYERDWBASIMULATION_H
 #define DECORATEDLAYERDWBASIMULATION_H
 
-#include "LayerDWBASimulation.h" // inheriting from
+#include "LayerDWBASimulation.h"
 
 class IInterferenceFunctionStrategy;
 
diff --git a/Core/Simulation/DistributionHandler.h b/Core/Simulation/DistributionHandler.h
index 397c4f3cffdea788f7b2831a9beb3d915769d7f2..08d243343af28d2b4852249464335b4945fcd97c 100644
--- a/Core/Simulation/DistributionHandler.h
+++ b/Core/Simulation/DistributionHandler.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Simulation/DistributionHandler.h
-//! @brief     Declares class DistributionHandler.
+//! @brief     Defines class DistributionHandler.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Simulation/GISASSimulation.h b/Core/Simulation/GISASSimulation.h
index c2cbaf5a5a54129842b897f0c6bcf882bf9b6958..46d09d6772b0d0c9543ae1d71854469e92041f66 100644
--- a/Core/Simulation/GISASSimulation.h
+++ b/Core/Simulation/GISASSimulation.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Simulation/GISASSimulation.h
-//! @brief     Declares class GISASSimulation.
+//! @brief     Defines class GISASSimulation.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef GISASSIMULATION_H
 #define GISASSIMULATION_H
 
-#include "Simulation.h" // inheriting from
+#include "Simulation.h"
 #include "Instrument.h"
 
 class ISample;
diff --git a/Core/Simulation/ISimulation.h b/Core/Simulation/ISimulation.h
index ea9cb565732349e58a3c213d1f949b93f92fd7ad..274c7281ad6dab850a54be27c5520bde5f4ebcfb 100644
--- a/Core/Simulation/ISimulation.h
+++ b/Core/Simulation/ISimulation.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Simulation/ISimulation.h
-//! @brief     Declares interface class ISimulation.
+//! @brief     Defines interface class ISimulation.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef ISIMULATION_H
 #define ISIMULATION_H
 
-#include "ICloneable.h" // inheriting from
+#include "ICloneable.h"
 #include <string>
 
 //! @class ISimulation
diff --git a/Core/Simulation/LayerDWBASimulation.h b/Core/Simulation/LayerDWBASimulation.h
index cd2628ec698d2155e4b1bd7524e7f5ad54a43afe..33f0cada4749ee3ac1f365d28961188af7ad6101 100644
--- a/Core/Simulation/LayerDWBASimulation.h
+++ b/Core/Simulation/LayerDWBASimulation.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Simulation/LayerDWBASimulation.h
-//! @brief     Declares class LayerDWBASimulation.
+//! @brief     Defines class LayerDWBASimulation.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef LAYERDWBASIMULATION_H
 #define LAYERDWBASIMULATION_H
 
-#include "DWBASimulation.h" // inheriting from
+#include "DWBASimulation.h"
 #include "LayerSpecularInfo.h"
 
 class Layer;
diff --git a/Core/Simulation/MultiLayerDWBASimulation.h b/Core/Simulation/MultiLayerDWBASimulation.h
index ec561cce7fefb93b16c108977805d3eb81a9f8d2..b3dc911102326168ff463e55173c5b4a90f37703 100644
--- a/Core/Simulation/MultiLayerDWBASimulation.h
+++ b/Core/Simulation/MultiLayerDWBASimulation.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Simulation/MultiLayerDWBASimulation.h
-//! @brief     Declares class MultiLayerDWBASimulation.
+//! @brief     Defines class MultiLayerDWBASimulation.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef MULTILAYERDWBASIMULATION_H
 #define MULTILAYERDWBASIMULATION_H
 
-#include "DWBASimulation.h" // inheriting from
+#include "DWBASimulation.h"
 #include "Complex.h"
 #include <map>
 
diff --git a/Core/Simulation/MultiLayerRoughnessDWBASimulation.cpp b/Core/Simulation/MultiLayerRoughnessDWBASimulation.cpp
index 6a4f60523f593a46892fb6fb5cb844b35160cc87..bcf5502ecd2058e38126c9e0f3fdc40fdec21a2c 100644
--- a/Core/Simulation/MultiLayerRoughnessDWBASimulation.cpp
+++ b/Core/Simulation/MultiLayerRoughnessDWBASimulation.cpp
@@ -22,7 +22,7 @@
 #include "LayerSpecularInfo.h"
 #include "MultiLayer.h"
 #include "SimulationElement.h"
-#include "Units.h"
+#include "Pi.h"
 
 // Diffuse scattering from rough interfaces is modelled after
 // Phys. Rev. B, vol. 51 (4), p. 2311 (1995)
@@ -118,7 +118,7 @@ double MultiLayerRoughnessDWBASimulation::evaluate(const SimulationElement& sim_
     }
 
     //! @TODO clarify complex vs double
-    return (autocorr+crosscorr.real())*Units::PI/4./wavelength/wavelength;
+    return (autocorr+crosscorr.real())*Pi::PI/4./wavelength/wavelength;
 }
 
 complex_t MultiLayerRoughnessDWBASimulation::get_refractive_term(size_t ilayer) const
diff --git a/Core/Simulation/MultiLayerRoughnessDWBASimulation.h b/Core/Simulation/MultiLayerRoughnessDWBASimulation.h
index 86c66035a5cf34221c3015fead128026a7500935..1b65b454d66e6778cd5a6e1f7604af8601934180 100644
--- a/Core/Simulation/MultiLayerRoughnessDWBASimulation.h
+++ b/Core/Simulation/MultiLayerRoughnessDWBASimulation.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Simulation/MultiLayerRoughnessDWBASimulation.h
-//! @brief     Declares class MultiLayerRoughnessDWBASimulation.
+//! @brief     Defines class MultiLayerRoughnessDWBASimulation.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef MULTILAYERROUGHNESSDWBASIMULATION_H
 #define MULTILAYERROUGHNESSDWBASIMULATION_H
 
-#include "DWBASimulation.h" // inheriting from
+#include "DWBASimulation.h"
 #include "Complex.h"
 
 class LayerSpecularInfo;
diff --git a/Core/Simulation/OMPISimulation.h b/Core/Simulation/OMPISimulation.h
index 4b61df84ed26051ff52435f181445beb10d08a53..10d0e6f72769ec537946bb901be8dd80a4a21933 100644
--- a/Core/Simulation/OMPISimulation.h
+++ b/Core/Simulation/OMPISimulation.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Simulation/OMPISimulation.h
-//! @brief     Declares class OMPISimulation.
+//! @brief     Defines class OMPISimulation.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Simulation/OffSpecSimulation.h b/Core/Simulation/OffSpecSimulation.h
index bc854b078df5281430da527fae33cca87a7994e5..6a38cafe383fef1b6fd524c63c4ba17d209176ba 100644
--- a/Core/Simulation/OffSpecSimulation.h
+++ b/Core/Simulation/OffSpecSimulation.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Simulation/OffSpecSimulation.h
-//! @brief     Declares class OffSpecSimulation.
+//! @brief     Defines class OffSpecSimulation.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef OFFSPECSIMULATION_H
 #define OFFSPECSIMULATION_H
 
-#include "Simulation.h" // inheriting from
+#include "Simulation.h"
 #include "Instrument.h"
 
 class Histogram2D;
diff --git a/Core/Simulation/ProgressHandler.h b/Core/Simulation/ProgressHandler.h
index f7bccc2b85ec114242563879dc9786be6054533a..f82fa9e12d0cfe9c59a89c2cea22e5ccc0632be9 100644
--- a/Core/Simulation/ProgressHandler.h
+++ b/Core/Simulation/ProgressHandler.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Simulation/ProgressHandler.h
-//! @brief     Declares class ProgressHandler.
+//! @brief     Defines class ProgressHandler.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Simulation/ProgressHandlerDWBA.h b/Core/Simulation/ProgressHandlerDWBA.h
index 48f0ed5656ad513f38af95d773d3260b642dc414..8219eed791cdbf41bc2138fcc28366ec6a80c74a 100644
--- a/Core/Simulation/ProgressHandlerDWBA.h
+++ b/Core/Simulation/ProgressHandlerDWBA.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Simulation/ProgressHandlerDWBA.h
-//! @brief     Declares class ProgressHandlerDWBA.
+//! @brief     Defines class ProgressHandlerDWBA.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Simulation/Simulation.h b/Core/Simulation/Simulation.h
index f23829826f98ce2f55de5a6a15c2e08a848cb25a..fe67bd6f05bec2bc5d96f8592f9cb2d43c64eabe 100644
--- a/Core/Simulation/Simulation.h
+++ b/Core/Simulation/Simulation.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Simulation/Simulation.h
-//! @brief     Declares class Simulation.
+//! @brief     Defines class Simulation.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Simulation/SpecularSimulation.h b/Core/Simulation/SpecularSimulation.h
index b0b8831f09794c7dcb8f0ccbde16a914b0ba24c3..fa9ede57271202da3c76ef5599fb991d0d8f0b22 100644
--- a/Core/Simulation/SpecularSimulation.h
+++ b/Core/Simulation/SpecularSimulation.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Simulation/SpecularSimulation.h
-//! @brief     Declares class SpecularSimulation.
+//! @brief     Defines class SpecularSimulation.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef SPECULARSIMULATION_H
 #define SPECULARSIMULATION_H
 
-#include "ICloneable.h" // inheriting from
+#include "ICloneable.h"
 #include "ILayerRTCoefficients.h"
 #include "IParameterized.h"
 #include "OutputData.h"
diff --git a/Core/SoftParticle/FormFactorGauss.cpp b/Core/SoftParticle/FormFactorGauss.cpp
index e841fc729398f3d162bb6c53afd6994b41337e59..8038cfcb59c31877ad22877daf4675c69f8c35d5 100644
--- a/Core/SoftParticle/FormFactorGauss.cpp
+++ b/Core/SoftParticle/FormFactorGauss.cpp
@@ -16,7 +16,7 @@
 #include "FormFactorGauss.h"
 #include "BornAgainNamespace.h"
 #include "Numeric.h"
-#include "Units.h"
+#include "Pi.h"
 
 FormFactorGauss::FormFactorGauss(double volume)
 {
@@ -45,8 +45,8 @@ complex_t FormFactorGauss::evaluate_for_q(const cvector_t q) const
     if (std::abs(qyr) > m_max_ql)
         return 0.0;
 
-    complex_t z_part = exp_I(qzHdiv2) * m_height * std::exp(-qzh * qzh / 4.0 / Units::PI);
-    double radial_part = m_width * m_width * std::exp(-(qxr * qxr + qyr * qyr) / 4.0 / Units::PI);
+    complex_t z_part = exp_I(qzHdiv2) * m_height * std::exp(-qzh * qzh / 4.0 / Pi::PI);
+    double radial_part = m_width * m_width * std::exp(-(qxr * qxr + qyr * qyr) / 4.0 / Pi::PI);
     complex_t result = radial_part * z_part;
     return result;
 }
@@ -56,5 +56,5 @@ void FormFactorGauss::initialize()
     setName(BornAgain::FFGaussType);
     registerNonnegativeLength(BornAgain::Width, &m_width);
     registerNonnegativeLength(BornAgain::Height, &m_height);
-    m_max_ql = std::sqrt(-4 * Units::PI * std::log(Numeric::double_min) / 3.0);
+    m_max_ql = std::sqrt(-4 * Pi::PI * std::log(Numeric::double_min) / 3.0);
 }
diff --git a/Core/SoftParticle/FormFactorGauss.h b/Core/SoftParticle/FormFactorGauss.h
index ca3929b58c9bd7b49969938c81d69daa76dca788..d04fdedc1c788177cea732b31410d8cdbcb0a00e 100644
--- a/Core/SoftParticle/FormFactorGauss.h
+++ b/Core/SoftParticle/FormFactorGauss.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/SoftParticle/FormFactorGauss.h
-//! @brief     Declares class FormFactorGauss.
+//! @brief     Defines class FormFactorGauss.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef FORMFACTORGAUSS_H
 #define FORMFACTORGAUSS_H
 
-#include "IFormFactorBorn.h" // inheriting from
+#include "IFormFactorBorn.h"
 
 //! @class FormFactorGauss
 //! @ingroup formfactors
diff --git a/Core/SoftParticle/FormFactorLorentz.cpp b/Core/SoftParticle/FormFactorLorentz.cpp
index d9435538e7a9faaba3f48bd688ff090948928aa1..d891952b1d06fd72c8d5416b38b8e57204a7886f 100644
--- a/Core/SoftParticle/FormFactorLorentz.cpp
+++ b/Core/SoftParticle/FormFactorLorentz.cpp
@@ -16,7 +16,7 @@
 #include "FormFactorLorentz.h"
 #include "AttLimits.h"
 #include "BornAgainNamespace.h"
-#include "Units.h"
+#include "Pi.h"
 
 using namespace BornAgain;
 
@@ -43,7 +43,7 @@ double FormFactorLorentz::getRadialExtension() const
 
 complex_t FormFactorLorentz::evaluate_for_q(const cvector_t q) const
 {
-    static const double sigma2 = 4.0*std::pow(Units::PI, 2.0/3.0);
+    static const double sigma2 = 4.0*std::pow(Pi::PI, 2.0/3.0);
     double R = m_width;
     double H = m_height;
 
diff --git a/Core/SoftParticle/FormFactorLorentz.h b/Core/SoftParticle/FormFactorLorentz.h
index 1e1ebf3a8727ae904e5a59319d2f0317a51405f9..da7952756237ab9c8211e67d783af294cb44e397 100644
--- a/Core/SoftParticle/FormFactorLorentz.h
+++ b/Core/SoftParticle/FormFactorLorentz.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/SoftParticle/FormFactorLorentz.h
-//! @brief     Declares class FormFactorLorentz.
+//! @brief     Defines class FormFactorLorentz.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef FORMFACTORLORENTZ_H
 #define FORMFACTORLORENTZ_H
 
-#include "IFormFactorBorn.h" // inheriting from
+#include "IFormFactorBorn.h"
 
 //! @class FormFactorLorentz
 //! @ingroup formfactors
diff --git a/Core/SoftParticle/FormFactorSphereGaussianRadius.h b/Core/SoftParticle/FormFactorSphereGaussianRadius.h
index 78dad8a0e06e6fc9a1288a441a7b928c8bbaeeb2..27e0b6bcd123797b2508674e22b6afce8b9e5c83 100644
--- a/Core/SoftParticle/FormFactorSphereGaussianRadius.h
+++ b/Core/SoftParticle/FormFactorSphereGaussianRadius.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/SoftParticle/FormFactorSphereGaussianRadius.h
-//! @brief     Declares and implements class FormFactorSphereGaussianRadius.
+//! @brief     Defines and implements class FormFactorSphereGaussianRadius.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/SoftParticle/FormFactorSphereLogNormalRadius.h b/Core/SoftParticle/FormFactorSphereLogNormalRadius.h
index 19511f9e59f06fa06100e32518857e0084bc03d9..952fe3d86e1bbcbf9db87d789649ab4a24142777 100644
--- a/Core/SoftParticle/FormFactorSphereLogNormalRadius.h
+++ b/Core/SoftParticle/FormFactorSphereLogNormalRadius.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/SoftParticle/FormFactorSphereLogNormalRadius.h
-//! @brief     Declares and implements class FormFactorSphereLogNormalRadius.
+//! @brief     Defines and implements class FormFactorSphereLogNormalRadius.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/SoftParticle/FormFactorSphereUniformRadius.cpp b/Core/SoftParticle/FormFactorSphereUniformRadius.cpp
index fc487dd0fa8745b46c1e9166f539078bb6eccc3b..66383f1629bfa8d161f8a18c43bb90ed2edfeb83 100644
--- a/Core/SoftParticle/FormFactorSphereUniformRadius.cpp
+++ b/Core/SoftParticle/FormFactorSphereUniformRadius.cpp
@@ -17,7 +17,7 @@
 #include "BornAgainNamespace.h"
 #include "Exceptions.h"
 #include "Numeric.h"
-#include "Units.h"
+#include "Pi.h"
 
 FormFactorSphereUniformRadius::FormFactorSphereUniformRadius(double mean,
         double full_width)
@@ -40,10 +40,10 @@ complex_t FormFactorSphereUniformRadius::evaluate_for_q(const cvector_t q) const
     double q2 = std::norm(q.x()) + std::norm(q.y()) + std::norm(q.z());
     double q_r = std::sqrt(q2);
     if (q_r*R < Numeric::double_epsilon)
-        return (4.0*Units::PI*R*R*R + Units::PI*R*W*W)/3.0;
+        return (4.0*Pi::PI*R*R*R + Pi::PI*R*W*W)/3.0;
     double qR = q_r*R;
     double qW = q_r*W;
-    double nominator = 4*Units::PI*( 4*std::sin(qR)*std::sin(qW/2.0)
+    double nominator = 4*Pi::PI*( 4*std::sin(qR)*std::sin(qW/2.0)
                                      - qW*std::cos(qW/2.0)*std::sin(qR)
                                      - 2.0*qR*std::cos(qR)*std::sin(qW/2.0) );
     return nominator/(q2*q2*W);
diff --git a/Core/SoftParticle/FormFactorSphereUniformRadius.h b/Core/SoftParticle/FormFactorSphereUniformRadius.h
index 2151135385433e5c4556ce126df83bbab5062bda..166490dec287db424c4b291f4f9443a4684eba3c 100644
--- a/Core/SoftParticle/FormFactorSphereUniformRadius.h
+++ b/Core/SoftParticle/FormFactorSphereUniformRadius.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/SoftParticle/FormFactorSphereUniformRadius.h
-//! @brief     Declares class FormFactorSphereUniformRadius.
+//! @brief     Defines class FormFactorSphereUniformRadius.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/StandardSamples/BoxCompositionBuilder.h b/Core/StandardSamples/BoxCompositionBuilder.h
index c6508d3b4d508538c954089e4a6b899868863803..daf1f474d3bb69a1f30b0e6230aa886272044f2f 100644
--- a/Core/StandardSamples/BoxCompositionBuilder.h
+++ b/Core/StandardSamples/BoxCompositionBuilder.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/StandardSamples/BoxCompositionBuilder.h
-//! @brief     Declares classes of BoxCompositionBuilder family.
+//! @brief     Defines classes of BoxCompositionBuilder family.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef BOXCOMPOSITIONBUILDER_H
 #define BOXCOMPOSITIONBUILDER_H
 
-#include "ISampleBuilder.h" // inheriting from
+#include "ISampleBuilder.h"
 
 class ISample;
 class HomogeneousMaterial;
diff --git a/Core/StandardSamples/CoreShellParticleBuilder.h b/Core/StandardSamples/CoreShellParticleBuilder.h
index 612160bdcba1391fee323ec88ceb6319c72f635d..deab92c833a34e66538889808a8fcbb86bb89027 100644
--- a/Core/StandardSamples/CoreShellParticleBuilder.h
+++ b/Core/StandardSamples/CoreShellParticleBuilder.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/StandardSamples/CoreShellParticleBuilder.h
-//! @brief     Declares class CoreShellParticleBuilder.
+//! @brief     Defines class CoreShellParticleBuilder.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef CORESHELLPARTICLEBUILDER_H
 #define CORESHELLPARTICLEBUILDER_H
 
-#include "ISampleBuilder.h" // inheriting from
+#include "ISampleBuilder.h"
 
 class ISample;
 
diff --git a/Core/StandardSamples/CustomMorphologyBuilder.h b/Core/StandardSamples/CustomMorphologyBuilder.h
index a22883a2acb57972b1931b8e595c279c59455662..80190f23488f78f59e572c3bfadea2242c301cba 100644
--- a/Core/StandardSamples/CustomMorphologyBuilder.h
+++ b/Core/StandardSamples/CustomMorphologyBuilder.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/StandardSamples/CustomMorphologyBuilder.h
-//! @brief     Declares class CustomMorphologyBuilder.
+//! @brief     Defines class CustomMorphologyBuilder.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef CUSTOMMORPHOLOGYBUILDER_H
 #define CUSTOMMORPHOLOGYBUILDER_H
 
-#include "ISampleBuilder.h" // inheriting from
+#include "ISampleBuilder.h"
 
 class ISample;
 
diff --git a/Core/StandardSamples/CylindersAndPrismsBuilder.h b/Core/StandardSamples/CylindersAndPrismsBuilder.h
index a99b5fa745d728e963325c3874667fbb6fb6ce84..2ae54d1913999e1a17346270582b06b10d46e5bf 100644
--- a/Core/StandardSamples/CylindersAndPrismsBuilder.h
+++ b/Core/StandardSamples/CylindersAndPrismsBuilder.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/StandardSamples/CylindersAndPrismsBuilder.h
-//! @brief     Declares class CylindersAndPrismsBuilder.
+//! @brief     Defines class CylindersAndPrismsBuilder.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef CYLINDERSANDPRISMSBUILDER_H
 #define CYLINDERSANDPRISMSBUILDER_H
 
-#include "ISampleBuilder.h" // inheriting from
+#include "ISampleBuilder.h"
 
 class ISample;
 
diff --git a/Core/StandardSamples/CylindersBuilder.h b/Core/StandardSamples/CylindersBuilder.h
index 83d53afc7f94a897f91e4ac47c945ab524f430c3..7b3bedf086c63f21abdb39af4254479a84a5b950 100644
--- a/Core/StandardSamples/CylindersBuilder.h
+++ b/Core/StandardSamples/CylindersBuilder.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/StandardSamples/CylindersBuilder.h
-//! @brief     Declares classes of CylindersBuilder family.
+//! @brief     Defines classes of CylindersBuilder family.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef CYLINDERSBUILDER_H
 #define CYLINDERSBUILDER_H
 
-#include "ISampleBuilder.h" // inheriting from
+#include "ISampleBuilder.h"
 
 class ISample;
 
diff --git a/Core/StandardSamples/IFactory.h b/Core/StandardSamples/IFactory.h
index 5a2b18a85081ac11296393a880d991844bd39ff8..10aff183ecf736088aed2674cde1187344efc677 100644
--- a/Core/StandardSamples/IFactory.h
+++ b/Core/StandardSamples/IFactory.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/StandardSamples/IFactory.h
-//! @brief     Declares interface class IFactory.
+//! @brief     Defines interface class IFactory.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/StandardSamples/LatticeBuilder.h b/Core/StandardSamples/LatticeBuilder.h
index 0d05d4637b5fba3b713fd755083c9dce65ebcd69..5e55ec5d4af0c09b0d08f2f15603499b8e7a61f1 100644
--- a/Core/StandardSamples/LatticeBuilder.h
+++ b/Core/StandardSamples/LatticeBuilder.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/StandardSamples/LatticeBuilder.h
-//! @brief     Declares classes of LatticeBuilder family.
+//! @brief     Defines classes of LatticeBuilder family.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef LATTICEBUILDER_H
 #define LATTICEBUILDER_H
 
-#include "ISampleBuilder.h" // inheriting from
+#include "ISampleBuilder.h"
 
 class ISample;
 
diff --git a/Core/StandardSamples/LayersWithAbsorptionBuilder.h b/Core/StandardSamples/LayersWithAbsorptionBuilder.h
index e61e62d7cf8038abd88746fd32c0bb9d4ffea5c5..90012bb77aeb792ffa5f4c8a03ed334ae98f40c9 100644
--- a/Core/StandardSamples/LayersWithAbsorptionBuilder.h
+++ b/Core/StandardSamples/LayersWithAbsorptionBuilder.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/StandardSamples/LayersWithAbsorptionBuilder.h
-//! @brief     Declares class LayersWithAbsorptionBuilder.
+//! @brief     Defines class LayersWithAbsorptionBuilder.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef LAYERSWITHABSORPTIONBUILDER_H
 #define LAYERSWITHABSORPTIONBUILDER_H
 
-#include "ISampleBuilder.h" // inheriting from
+#include "ISampleBuilder.h"
 
 //! @class LayersWithAbsorptionBuilder
 //! @ingroup standard_samples
diff --git a/Core/StandardSamples/MagneticParticlesBuilder.h b/Core/StandardSamples/MagneticParticlesBuilder.h
index 7f6b73c4bf54ab6e47d0ce34953d78a3e4225438..bcfccfcb6cf8348c130edfd32fa5352c3a1cfedc 100644
--- a/Core/StandardSamples/MagneticParticlesBuilder.h
+++ b/Core/StandardSamples/MagneticParticlesBuilder.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/StandardSamples/MagneticParticlesBuilder.h
-//! @brief     Declares class to build magnetic samples
+//! @brief     Defines class to build magnetic samples
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef MAGNETICPARTICLESBUILDER_H
 #define MAGNETICPARTICLESBUILDER_H
 
-#include "ISampleBuilder.h" // inheriting from
+#include "ISampleBuilder.h"
 
 class ISample;
 
diff --git a/Core/StandardSamples/MesoCrystalBuilder.cpp b/Core/StandardSamples/MesoCrystalBuilder.cpp
index 6a5199b786489818724e5f2d22dfac3f4d4c4365..faa67500e232d3cad343d6d4e4f27a7230ee786d 100644
--- a/Core/StandardSamples/MesoCrystalBuilder.cpp
+++ b/Core/StandardSamples/MesoCrystalBuilder.cpp
@@ -26,6 +26,7 @@
 #include "MesoCrystal.h"
 #include "MultiLayer.h"
 #include "ParticleLayout.h"
+#include "Pi.h"
 #include "Units.h"
 
 MesoCrystalBuilder::MesoCrystalBuilder()
@@ -66,7 +67,7 @@ void MesoCrystalBuilder::init_parameters()
 ISample* MesoCrystalBuilder::buildSample() const
 {
     // create mesocrystal
-    double surface_density = m_surface_filling_ratio/Units::PI/m_meso_radius/m_meso_radius;
+    double surface_density = m_surface_filling_ratio/Pi::PI/m_meso_radius/m_meso_radius;
 //    complex_t n_particle(1.0-1.55e-5, 1.37e-6); // data from Artur
     // data from http://henke.lbl.gov/optical_constants/getdb2.html
     complex_t n_particle(1.0-2.84e-5, 4.7e-7);
@@ -99,7 +100,7 @@ ISample* MesoCrystalBuilder::buildSample() const
 //    double alpha_step = 5.0*Units::degree/n_alpha_rotation_steps;
 //    double alpha_start = - (n_alpha_rotation_steps/2.0)*alpha_step;
 
-    double phi_step = 2*Units::PI/3.0/n_max_phi_rotation_steps;
+    double phi_step = 2*Pi::PI/3.0/n_max_phi_rotation_steps;
     double phi_start = 0.0;
     for (size_t i=0; i<n_max_phi_rotation_steps; ++i) {
         for (size_t j=0; j<n_alpha_rotation_steps; ++j) {
diff --git a/Core/StandardSamples/MesoCrystalBuilder.h b/Core/StandardSamples/MesoCrystalBuilder.h
index 7b6db8e78a66acbc46b0c9f5f567f3fee69c3f90..4ec59458a6a59eed394b5933b67222d524e841a5 100644
--- a/Core/StandardSamples/MesoCrystalBuilder.h
+++ b/Core/StandardSamples/MesoCrystalBuilder.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/StandardSamples/MesoCrystalBuilder.h
-//! @brief     Declares class MesoCrystalBuilder.
+//! @brief     Defines class MesoCrystalBuilder.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef MESOCRYSTALBUILDER_H
 #define MESOCRYSTALBUILDER_H
 
-#include "ISampleBuilder.h" // inheriting from
+#include "ISampleBuilder.h"
 #include "Complex.h"
 
 class IFormFactor;
diff --git a/Core/StandardSamples/MultiLayerWithRoughnessBuilder.h b/Core/StandardSamples/MultiLayerWithRoughnessBuilder.h
index cfdda830f1d6a9ae92c8d4b23aab41e2c3cc99e3..16fe62b9389a3897d7c96e93838a501300bc1d80 100644
--- a/Core/StandardSamples/MultiLayerWithRoughnessBuilder.h
+++ b/Core/StandardSamples/MultiLayerWithRoughnessBuilder.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/StandardSamples/MultiLayerWithRoughnessBuilder.h
-//! @brief     Declares class MultiLayerWithRoughnessBuilder.
+//! @brief     Defines class MultiLayerWithRoughnessBuilder.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef MULTILAYERWITHROUGHNESSBUILDER_H
 #define MULTILAYERWITHROUGHNESSBUILDER_H
 
-#include "ISampleBuilder.h" // inheriting from
+#include "ISampleBuilder.h"
 
 class ISample;
 
diff --git a/Core/StandardSamples/MultipleLayoutBuilder.h b/Core/StandardSamples/MultipleLayoutBuilder.h
index e707ec9e5471eb8d9071eccf9147bf52c40c90f6..0782ca3e50602256afe62314a1107aace0e5df49 100644
--- a/Core/StandardSamples/MultipleLayoutBuilder.h
+++ b/Core/StandardSamples/MultipleLayoutBuilder.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/StandardSamples/MultipleLayoutBuilder.h
-//! @brief     Declares class MultipleLayoutBuilder.
+//! @brief     Defines class MultipleLayoutBuilder.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef MULTIPLELAYOUTBUILDER_H
 #define MULTIPLELAYOUTBUILDER_H
 
-#include "ISampleBuilder.h" // inheriting from
+#include "ISampleBuilder.h"
 
 class ISample;
 
diff --git a/Core/StandardSamples/ParaCrystalBuilder.cpp b/Core/StandardSamples/ParaCrystalBuilder.cpp
index 79bc9b3941d66fd91cb42c0af0a4775fcd26c2bb..0988f9529fcff43110b0cf49c4009c1803e49c88 100644
--- a/Core/StandardSamples/ParaCrystalBuilder.cpp
+++ b/Core/StandardSamples/ParaCrystalBuilder.cpp
@@ -234,7 +234,7 @@ ISample* IsGISAXS08BBuilder::buildSample() const
     Layer substrate_layer(substrate_material);
 
     InterferenceFunction2DParaCrystal interference_function(
-        10.0 * Units::nanometer, 10.0 * Units::nanometer, Units::PI / 2.0, 0.0, 0.0);
+        10.0 * Units::nanometer, 10.0 * Units::nanometer, Pi::PI / 2.0, 0.0, 0.0);
     interference_function.setDomainSizes(20.0*Units::micrometer,
             20.0*Units::micrometer);
     FTDistribution2DCauchy pdf1(0.5*Units::nanometer, 0.5*Units::nanometer);
diff --git a/Core/StandardSamples/ParaCrystalBuilder.h b/Core/StandardSamples/ParaCrystalBuilder.h
index b9492c199e38b8e0dd6eed50ef01350b4d1bd613..98e00ae76ec93a463ff0fa1cce49a2c48564f764 100644
--- a/Core/StandardSamples/ParaCrystalBuilder.h
+++ b/Core/StandardSamples/ParaCrystalBuilder.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/StandardSamples/ParaCrystalBuilder.h
-//! @brief     Declares classes of ParaCrystalBuilder family.
+//! @brief     Defines classes of ParaCrystalBuilder family.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef PARACRYSTALBUILDER_H
 #define PARACRYSTALBUILDER_H
 
-#include "ISampleBuilder.h" // inheriting from
+#include "ISampleBuilder.h"
 
 class IFTDistribution2D;
 class ISample;
diff --git a/Core/StandardSamples/ParticleCompositionBuilder.h b/Core/StandardSamples/ParticleCompositionBuilder.h
index b34fb5481baa85bb350e2abd1956e4c8940dd49e..89f93defdd0d092b60c758b1128c4d920e5102ff 100644
--- a/Core/StandardSamples/ParticleCompositionBuilder.h
+++ b/Core/StandardSamples/ParticleCompositionBuilder.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/StandardSamples/ParticleCompositionBuilder.h
-//! @brief     Declares class ParticleCompositionBuilder.
+//! @brief     Defines class ParticleCompositionBuilder.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef PARTICLECOMPOSITIONBUILDER_H
 #define PARTICLECOMPOSITIONBUILDER_H
 
-#include "ISampleBuilder.h" // inheriting from
+#include "ISampleBuilder.h"
 
 //! @class ParticleCompositionBuilder
 //! @ingroup standard_samples
diff --git a/Core/StandardSamples/ParticleDistributionsBuilder.h b/Core/StandardSamples/ParticleDistributionsBuilder.h
index 11822c0924a89d63537ad8e1233e585fb395396a..c82392e38bbcb376d2439c3a17bd94e15cb47f45 100644
--- a/Core/StandardSamples/ParticleDistributionsBuilder.h
+++ b/Core/StandardSamples/ParticleDistributionsBuilder.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/StandardSamples/ParticleDistributionsBuilder.h
-//! @brief     Declares classes of with different types of particle distributions.
+//! @brief     Defines classes of with different types of particle distributions.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef PARTICLEDISTRIBUTIONSBUILDER_H
 #define PARTICLEDISTRIBUTIONSBUILDER_H
 
-#include "ISampleBuilder.h" // inheriting from
+#include "ISampleBuilder.h"
 
 //! @class CylindersWithSizeDistributionBuilder
 //! @ingroup standard_samples
diff --git a/Core/StandardSamples/ParticleInTheAirBuilder.h b/Core/StandardSamples/ParticleInTheAirBuilder.h
index 8c9d77a81c5c4721038354e5d5683220494b9624..217e910f317d4af8810da7210528d62d0c524e4a 100644
--- a/Core/StandardSamples/ParticleInTheAirBuilder.h
+++ b/Core/StandardSamples/ParticleInTheAirBuilder.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/StandardSamples/ParticleInTheAirBuilder.h
-//! @brief     Declares class ParticleInTheAirBuilder.
+//! @brief     Defines class ParticleInTheAirBuilder.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef PARTICLEINTHEAIRBUILDER_H
 #define PARTICLEINTHEAIRBUILDER_H
 
-#include "ISampleBuilder.h" // inheriting from
+#include "ISampleBuilder.h"
 
 //! @class ParticleInTheAirBuilder
 //! @ingroup standard_samples
diff --git a/Core/StandardSamples/RipplesBuilder.h b/Core/StandardSamples/RipplesBuilder.h
index eb3c6022aa940453aa9ff25f5cad0409e40bdb1a..61f51158a8a4b2bf274a56e4175f95a2b2d6954b 100644
--- a/Core/StandardSamples/RipplesBuilder.h
+++ b/Core/StandardSamples/RipplesBuilder.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/StandardSamples/RipplesBuilder.h
-//! @brief     Declares classes to build various ripples.
+//! @brief     Defines classes to build various ripples.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef RIPPLESBUILDER_H
 #define RIPPLESBUILDER_H
 
-#include "ISampleBuilder.h" // inheriting from
+#include "ISampleBuilder.h"
 
 //! @class CosineRippleBuilder
 //! @ingroup standard_samples
diff --git a/Core/StandardSamples/RotatedPyramidsBuilder.h b/Core/StandardSamples/RotatedPyramidsBuilder.h
index a4bfb5057522b4e516ecf4fe5e956946733aa127..46216cb99ad6b657da99d47da9785060d043529e 100644
--- a/Core/StandardSamples/RotatedPyramidsBuilder.h
+++ b/Core/StandardSamples/RotatedPyramidsBuilder.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/StandardSamples/RotatedPyramidsBuilder.h
-//! @brief     Declares class RotatedPyramidsBuilder.
+//! @brief     Defines class RotatedPyramidsBuilder.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef ROTATEDPYRAMIDSBUILDER_H
 #define ROTATEDPYRAMIDSBUILDER_H
 
-#include "ISampleBuilder.h" // inheriting from
+#include "ISampleBuilder.h"
 
 //! @class RotatedPyramidsBuilder
 //! @ingroup standard_samples
diff --git a/Core/StandardSamples/SampleBuilderFactory.h b/Core/StandardSamples/SampleBuilderFactory.h
index fdd840e9f466a5cc6fe22c74d139616d42fbed09..e925c25aa9e77cc926a9108f8b87f55f8f5c6f62 100644
--- a/Core/StandardSamples/SampleBuilderFactory.h
+++ b/Core/StandardSamples/SampleBuilderFactory.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/StandardSamples/SampleBuilderFactory.h
-//! @brief     Declares class SampleBuilderFactory.
+//! @brief     Defines class SampleBuilderFactory.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef SAMPLEBUILDERFACTORY_H
 #define SAMPLEBUILDERFACTORY_H
 
-#include "IFactory.h" // inheriting from
+#include "IFactory.h"
 #include "ISampleBuilder.h"
 
 class ISample;
diff --git a/Core/StandardSamples/SimulationFactory.h b/Core/StandardSamples/SimulationFactory.h
index a449f258a6fe0491336a7dd6519ea43785a3dbf0..e631b92a5bfd03c022f43fe0c263bb06f37f3cac 100644
--- a/Core/StandardSamples/SimulationFactory.h
+++ b/Core/StandardSamples/SimulationFactory.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/StandardSamples/SimulationFactory.h
-//! @brief     Declares class SimulationFactory.
+//! @brief     Defines class SimulationFactory.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef SIMULATIONFACTORY_H
 #define SIMULATIONFACTORY_H
 
-#include "IFactory.h" // inheriting from
+#include "IFactory.h"
 
 //! @class SimulationFactory
 //! @ingroup standard_samples
diff --git a/Core/StandardSamples/SizeDistributionModelsBuilder.h b/Core/StandardSamples/SizeDistributionModelsBuilder.h
index 12c6f6ede6a884ea1442f8e7822703241877a75b..bbe0dfa34ce6f7a0cabffad96a193ff3cc872d9d 100644
--- a/Core/StandardSamples/SizeDistributionModelsBuilder.h
+++ b/Core/StandardSamples/SizeDistributionModelsBuilder.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/StandardSamples/SizeDistributionModelsBuilder.h
-//! @brief     Declares various sample builder classes to test DA, LMA, SSCA approximations
+//! @brief     Defines various sample builder classes to test DA, LMA, SSCA approximations
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef SIZEDISTRIBUTIONMODELSBUILDER_H
 #define SIZEDISTRIBUTIONMODELSBUILDER_H
 
-#include "ISampleBuilder.h" // inheriting from
+#include "ISampleBuilder.h"
 
 //! @class SizeDistributionDAModelBuilder
 //! @ingroup standard_samples
diff --git a/Core/StandardSamples/StandardSimulations.h b/Core/StandardSamples/StandardSimulations.h
index 9d19568d624459ca95531113ba8d6f4cb52b1ab6..bc11b50d5f1a6f8f6b924a9c4471059125f7e097 100644
--- a/Core/StandardSamples/StandardSimulations.h
+++ b/Core/StandardSamples/StandardSimulations.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/StandardSamples/StandardSimulations.h
-//! @brief     Declares namespace and functions for standard simulations.
+//! @brief     Defines namespace and functions for standard simulations.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/StandardSamples/TransformationsBuilder.h b/Core/StandardSamples/TransformationsBuilder.h
index 599b684385ee6a979c41a8d013b9f10be92c9b3f..c390e79a870488814eb5b99bd79c09add27213b2 100644
--- a/Core/StandardSamples/TransformationsBuilder.h
+++ b/Core/StandardSamples/TransformationsBuilder.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/StandardSamples/TransformationsBuilder.h
-//! @brief     Declares classes to build samples with different transformations.
+//! @brief     Defines classes to build samples with different transformations.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef TRANSFORMATIONSBUILDER_H
 #define TRANSFORMATIONSBUILDER_H
 
-#include "ISampleBuilder.h" // inheriting from
+#include "ISampleBuilder.h"
 
 //! @class TransformBoxBuilder
 //! @ingroup standard_samples
diff --git a/Core/StandardSamples/TwoDimLatticeBuilder.cpp b/Core/StandardSamples/TwoDimLatticeBuilder.cpp
index 559bffe25895263b670d24c9797114a009086cf7..817b1b4d6655f9427cc04a886e26dafba3184afa 100644
--- a/Core/StandardSamples/TwoDimLatticeBuilder.cpp
+++ b/Core/StandardSamples/TwoDimLatticeBuilder.cpp
@@ -40,8 +40,8 @@ ISample *SquareLatticeBuilder::buildSample() const
 
     std::unique_ptr<InterferenceFunction2DLattice> P_interference_function{
         InterferenceFunction2DLattice::createSquare(10.0 * Units::nanometer) };
-    FTDecayFunction2DCauchy pdf(300.0*Units::nanometer/2.0/Units::PI,
-                                100.0*Units::nanometer/2.0/Units::PI);
+    FTDecayFunction2DCauchy pdf(300.0*Units::nanometer/2.0/Pi::PI,
+                                100.0*Units::nanometer/2.0/Pi::PI);
     P_interference_function->setDecayFunction(pdf);
 
     // particles
@@ -76,9 +76,9 @@ ISample *CenteredSquareLatticeBuilder::buildSample() const
     Layer substrate_layer(substrate_material);
 
     InterferenceFunction2DLattice interference_function(10.0*Units::nanometer,
-            10.0*Units::nanometer, Units::PI/2.0);
-    FTDecayFunction2DCauchy pdf(300.0*Units::nanometer/2.0/Units::PI,
-                                100.0*Units::nanometer/2.0/Units::PI);
+            10.0*Units::nanometer, Pi::PI/2.0);
+    FTDecayFunction2DCauchy pdf(300.0*Units::nanometer/2.0/Pi::PI,
+                                100.0*Units::nanometer/2.0/Pi::PI);
     interference_function.setDecayFunction(pdf);
 
     FormFactorCylinder ff_cyl(5.0*Units::nanometer, 5.0*Units::nanometer);
@@ -119,8 +119,8 @@ ISample *RotatedSquareLatticeBuilder::buildSample() const
 
     std::unique_ptr<InterferenceFunction2DLattice> P_interference_function{
         InterferenceFunction2DLattice::createSquare(10.0 * Units::nanometer, 30.0 * Units::degree)};
-    FTDecayFunction2DCauchy pdf(300.0*Units::nanometer/2.0/Units::PI,
-                               100.0*Units::nanometer/2.0/Units::PI);
+    FTDecayFunction2DCauchy pdf(300.0*Units::nanometer/2.0/Pi::PI,
+                               100.0*Units::nanometer/2.0/Pi::PI);
     pdf.setGamma(30.0*Units::degree);
     P_interference_function->setDecayFunction(pdf);
 
diff --git a/Core/StandardSamples/TwoDimLatticeBuilder.h b/Core/StandardSamples/TwoDimLatticeBuilder.h
index 56093a2e8ff2e843c5f4b51274340c815a5546c5..7fb6cff4b3b2e3c34d76bbe2ade1d66ca8f17439 100644
--- a/Core/StandardSamples/TwoDimLatticeBuilder.h
+++ b/Core/StandardSamples/TwoDimLatticeBuilder.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/StandardSamples/TwoDimLatticeBuilder.h
-//! @brief     Declares class IsGISAXS06Builder.
+//! @brief     Defines class IsGISAXS06Builder.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef TWODIMLATTICEBUILDER_H
 #define TWODIMLATTICEBUILDER_H
 
-#include "ISampleBuilder.h" // inheriting from
+#include "ISampleBuilder.h"
 
 //! @class SquareLatticeBuilder
 //! @ingroup standard_samples
diff --git a/Core/Tools/FileSystem.cpp b/Core/Tools/FileSystem.cpp
index e6ec9abbbbd912a0da2371872d720b3a333a1274..e0932920bf9a99021cf538e79324ac363187effc 100644
--- a/Core/Tools/FileSystem.cpp
+++ b/Core/Tools/FileSystem.cpp
@@ -59,6 +59,12 @@ std::string FileSystem::GetJoinPath(const std::string &spath1, const std::string
     return full_path.string();
 }
 
+//! Returns path without directory part ("Foo/Bar/Doz.int.gz" -> "Doz.int.gz")
+std::string FileSystem::filename(const std::string& path)
+{
+    return boost::filesystem::path(path).filename().string();
+}
+
 //! Returns file names that agree with glob pattern.
 std::vector<std::string> FileSystem::glob(const std::string& pattern)
 {
diff --git a/Core/Tools/FileSystem.h b/Core/Tools/FileSystem.h
index 7455f1882ce2d74fa04a95d91474c4656ad4e71e..6d487bac2eae91865c4c369b46fdf63c0253cfa7 100644
--- a/Core/Tools/FileSystem.h
+++ b/Core/Tools/FileSystem.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Tools/FileSystem.h
-//! @brief     Declares class FileSystem
+//! @brief     Defines class FileSystem
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -22,7 +22,7 @@
 
 //! Utilities to deal with file system.
 
-namespace  FileSystem {
+namespace FileSystem {
 
     //! Returns path to the current (working) directory
     std::string GetWorkingPath();
@@ -39,6 +39,9 @@ namespace  FileSystem {
     //! join paths together
     std::string GetJoinPath(const std::string& spath1, const std::string& spath2);
 
+    //! Returns path without directory part ("Foo/Bar/Doz.int.gz" -> "Doz.int.gz")
+    std::string filename(const std::string& path);
+
     //! Returns file names that agree with glob pattern.
     std::vector<std::string> glob(const std::string& pattern);
 
diff --git a/Core/Tools/IntegratorComplex.h b/Core/Tools/IntegratorComplex.h
index 8ef1dd003076c7dc7718dd04100e2985a877d4a2..91558c6043b4c825f99515d82140770d275389dd 100644
--- a/Core/Tools/IntegratorComplex.h
+++ b/Core/Tools/IntegratorComplex.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Tools/IntegratorComplex.h
-//! @brief     Declares and implements class template IntegratorComplex.
+//! @brief     Defines and implements class template IntegratorComplex.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Tools/IntegratorMCMiser.h b/Core/Tools/IntegratorMCMiser.h
index b7f42dad27ab3b4cb6e1f61cc730f2c6a04388bf..57e77b8bb9fdef8787eff4aa59d11ba38089ccae 100644
--- a/Core/Tools/IntegratorMCMiser.h
+++ b/Core/Tools/IntegratorMCMiser.h
@@ -4,7 +4,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Tools/IntegratorMCMiser.h
-//! @brief     Declares and implements template class IntegratorMCMiser.
+//! @brief     Defines and implements template class IntegratorMCMiser.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Tools/IntegratorReal.h b/Core/Tools/IntegratorReal.h
index 1575284e2d6dbf4e19b9ece51dde9113ce3ac7f9..39c8bcd8d35a92fd77075491c86f75144df88162 100644
--- a/Core/Tools/IntegratorReal.h
+++ b/Core/Tools/IntegratorReal.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Tools/IntegratorReal.h
-//! @brief     Declares and implements class template IntegratorReal.
+//! @brief     Defines and implements class template IntegratorReal.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Tools/MathFunctions.cpp b/Core/Tools/MathFunctions.cpp
index 12bf257b939ee841c0306060ac2d8b1b5d8daa14..a429139923ff882158dcd942e6bff31b2e7288a4 100644
--- a/Core/Tools/MathFunctions.cpp
+++ b/Core/Tools/MathFunctions.cpp
@@ -15,7 +15,7 @@
 
 #include "MathFunctions.h"
 #include "Numeric.h"
-#include "Units.h"
+#include "Pi.h"
 #include <gsl/gsl_sf_bessel.h>
 #include <gsl/gsl_sf_erf.h>
 #include <gsl/gsl_sf_expint.h>
@@ -32,7 +32,7 @@
 
 double MathFunctions::StandardNormal(double x)
 {
-    return std::exp(-x * x / 2.0) / std::sqrt(Units::PI2);
+    return std::exp(-x * x / 2.0) / std::sqrt(Pi::PI2);
 }
 
 double MathFunctions::Gaussian(double x, double average, double std_dev)
@@ -49,7 +49,7 @@ double MathFunctions::IntegratedGaussian(double x, double average, double std_de
 
 double MathFunctions::cot(double x)
 {
-    return tan(Units::PID2-x);
+    return tan(Pi::PID2-x);
 }
 
 double MathFunctions::Si(double x)  // int_0^x du Sin(u)/u
@@ -59,7 +59,7 @@ double MathFunctions::Si(double x)  // int_0^x du Sin(u)/u
 
 double MathFunctions::sinc(double x)  // Sin(x)/x
 {
-    return gsl_sf_sinc(x/Units::PI);
+    return gsl_sf_sinc(x/Pi::PI);
 }
 
 complex_t MathFunctions::sinc(const complex_t z)  // Sin(x)/x
@@ -188,7 +188,7 @@ complex_t MathFunctions::Bessel_J0_PowSer(const complex_t z)
             kz = 10; //   "      "     "  12
         else
             kz = 12; //   "      "     "  14
-        complex_t ct1 = z1 - Units::PID4;
+        complex_t ct1 = z1 - Pi::PID4;
         complex_t cp0 = 1.0;
         complex_t cq0 = -0.125;
         const complex_t z1m2 = 1. / (z1*z1); // faster than std::pow(z1, -2.0) ??
@@ -260,7 +260,7 @@ complex_t MathFunctions::Bessel_J1_PowSer(const complex_t z)
             cq1 += b1[k] * ptmp; // division by z1 postponed to final sum
             ptmp *= z1m2;
         }
-        const complex_t ct2 = z1 - 0.75 * Units::PI;
+        const complex_t ct2 = z1 - 0.75 * Pi::PI;
         cj1 = std::sqrt(M_2_PI / z1) * (cp1 * std::cos(ct2) - cq1/z1 * std::sin(ct2));
     }
     if (std::real(z) < 0.0)
diff --git a/Core/Tools/MathFunctions.h b/Core/Tools/MathFunctions.h
index ce98233dc96a1ae74578f25c83d7d12d279acc83..112da62990719d5d9b23af7746abec90ec930504 100644
--- a/Core/Tools/MathFunctions.h
+++ b/Core/Tools/MathFunctions.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Tools/MathFunctions.h
-//! @brief     Declares functions in namespace MathFunctions.
+//! @brief     Defines functions in namespace MathFunctions.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Tools/NumpyUtils.h b/Core/Tools/NumpyUtils.h
index 2c32c6a885d4f12c9eda8006cb74dc904fdeef76..b4d52ca1a85efc4e05da22c25d1ce44dfceacfd0 100644
--- a/Core/Tools/NumpyUtils.h
+++ b/Core/Tools/NumpyUtils.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Tools/NumpyUtils.h
-//! @brief     Declares various functions to interact from numpy on Python side
+//! @brief     Defines various functions to interact from numpy on Python side
 //!
 //! @homepage  http://bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Tools/Precomputed.h b/Core/Tools/Precomputed.h
index 14d0a9dbe9e491ee49812373107c0d2d740330b6..7ae087265a612ff2c52e2006a68b6d89acf1bc05 100644
--- a/Core/Tools/Precomputed.h
+++ b/Core/Tools/Precomputed.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Tools/Precomputed.h
-//! @brief     Declares classes Precomputed, providing precomputed constants
+//! @brief     Defines classes Precomputed, providing precomputed constants
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #define PRECOMPUTED_H
 
 #include "WinDllMacros.h"
-#include "ISingleton.h" // inheriting from
+#include "ISingleton.h"
 #include <vector>
 
 //! This class contains precomputed constants.
diff --git a/Core/Tools/Utils.h b/Core/Tools/Utils.h
index b01ad32a28cf407d10c831709e36f8688f60fd59..ed1e38c5a985a64b6ee3ba8c93d6f23b86b7b3ff 100644
--- a/Core/Tools/Utils.h
+++ b/Core/Tools/Utils.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Tools/Utils.h
-//! @brief     Declares various stuff in namespace Utils.
+//! @brief     Defines various stuff in namespace Utils.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Vector/FastVector.h b/Core/Vector/FastVector.h
index ce91257c222107d77dba747d60b1522029933045..5d1f9fd590806c5bb225499457425ab5a5e048a7 100644
--- a/Core/Vector/FastVector.h
+++ b/Core/Vector/FastVector.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Vector/FastVector.h
-//! @brief     Declares class KVectorContainer.
+//! @brief     Defines class KVectorContainer.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Vector/Vectors3D.h b/Core/Vector/Vectors3D.h
index 600596c0fefe47c0f1d2e697412f1ce6981c633e..9ef44c10b76efad67c4c888464bfe5800e204be6 100644
--- a/Core/Vector/Vectors3D.h
+++ b/Core/Vector/Vectors3D.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Vector/Vectors3D.h
-//! @brief     Declares basic vectors in R^3 and C^3.
+//! @brief     Defines basic vectors in R^3 and C^3.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Core/Vector/WavevectorInfo.h b/Core/Vector/WavevectorInfo.h
index bd4dbc0318d063c05254ad270dd05e8a575c7585..d3a0892851d512d8f5483df959de002b5faee406 100644
--- a/Core/Vector/WavevectorInfo.h
+++ b/Core/Vector/WavevectorInfo.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Core/Vector/WavevectorInfo.h
-//! @brief     Declares WavevectorInfo.
+//! @brief     Defines WavevectorInfo.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Fit/Minimizer/AlgorithmNames.h b/Fit/Minimizer/AlgorithmNames.h
index 205afa2fc77053b0a7ce978fa9c8e38a98bc1b7a..7731e69341a0217bdb5406ea06d229cb0ca4990b 100644
--- a/Fit/Minimizer/AlgorithmNames.h
+++ b/Fit/Minimizer/AlgorithmNames.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Fit/Minimizer/AlgorithmNames.h
-//! @brief     Declares namespace AlgorithmNames.
+//! @brief     Defines namespace AlgorithmNames.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Fit/Minimizer/IMinimizer.h b/Fit/Minimizer/IMinimizer.h
index 2f8bdf823c339413c4e5d3964d9f414373a7e893..45cc2f8ff7e19bfb87cfd09bc190a14187429485 100644
--- a/Fit/Minimizer/IMinimizer.h
+++ b/Fit/Minimizer/IMinimizer.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Fit/Minimizer/IMinimizer.h
-//! @brief     Declares class IMinimizer.
+//! @brief     Defines class IMinimizer.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Fit/Minimizer/MinimizerFactory.h b/Fit/Minimizer/MinimizerFactory.h
index 7e298f637e42ab9f33af9186c768e1d03b84289f..72ba63d3b6ddd3df7889a43677a79dada77637ce 100644
--- a/Fit/Minimizer/MinimizerFactory.h
+++ b/Fit/Minimizer/MinimizerFactory.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Fit/Minimizer/MinimizerFactory.h
-//! @brief     Declares class MinimizerFactory.
+//! @brief     Defines class MinimizerFactory.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Fit/Minimizer/MinimizerLibrary.h b/Fit/Minimizer/MinimizerLibrary.h
index 42607321f2c11369fa706afffe31565bfe748869..622fd00312e74b495d71e3a9a3ffb1d525da6bff 100644
--- a/Fit/Minimizer/MinimizerLibrary.h
+++ b/Fit/Minimizer/MinimizerLibrary.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Fit/Minimizer/MinimizerLibrary.h
-//! @brief     Declares namespace MinimizerLibrary.
+//! @brief     Defines namespace MinimizerLibrary.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Fit/Minimizer/MinimizerOptions.h b/Fit/Minimizer/MinimizerOptions.h
index f07e2967548df5f382da7dc4b92467cc8d078021..5979ea8716818bb55029da565b28ee166da2d449 100644
--- a/Fit/Minimizer/MinimizerOptions.h
+++ b/Fit/Minimizer/MinimizerOptions.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Fit/Minimizer/MinimizerOptions.h
-//! @brief     Declares class MinimizerOptions.
+//! @brief     Defines class MinimizerOptions.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Fit/Minimizer/TrivialMinimizer.h b/Fit/Minimizer/TrivialMinimizer.h
index 220ae3e75ed6d6bf40c4dbbb6c12d08cbd047e10..680349b9e4bebf2d3422ec8cd8d8c4e7927e97c1 100644
--- a/Fit/Minimizer/TrivialMinimizer.h
+++ b/Fit/Minimizer/TrivialMinimizer.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Fit/Minimizer/TrivialMinimizer.h
-//! @brief     Declares class TrivialMinimizer.
+//! @brief     Defines class TrivialMinimizer.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef TRIVIALMINIMIZER_H
 #define TRIVIALMINIMIZER_H
 
-#include "IMinimizer.h" // inheriting from
+#include "IMinimizer.h"
 #include "FitSuiteParameters.h"
 
 //! @class TrivialMinimizer
diff --git a/Fit/Parameters/AttLimits.h b/Fit/Parameters/AttLimits.h
index ac036030795cc757db7b0ae23ab2d6068b133f53..b1803d0f991d5dced18f3c518a5d5ec8bde8cf31 100644
--- a/Fit/Parameters/AttLimits.h
+++ b/Fit/Parameters/AttLimits.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Fit/Parameters/AttLimits.h
-//! @brief     Declares class AttLimits.
+//! @brief     Defines class AttLimits.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Fit/Parameters/FitParameter.h b/Fit/Parameters/FitParameter.h
index 4cd07dcc0bf12784c2f12b42e44fc054fa9bf861..938ce7286d2c62d36cc2355aad389f5cbb8c358c 100644
--- a/Fit/Parameters/FitParameter.h
+++ b/Fit/Parameters/FitParameter.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Fit/Parameters/FitParameter.h
-//! @brief     Declares class FitParameter.
+//! @brief     Defines class FitParameter.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Fit/Parameters/FitSuiteParameters.h b/Fit/Parameters/FitSuiteParameters.h
index a29aefb091e793c0fd6c5ee64bf0af6a2851ef1c..09e0a715180877cb69cdb7e35b5089ff312501d0 100644
--- a/Fit/Parameters/FitSuiteParameters.h
+++ b/Fit/Parameters/FitSuiteParameters.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Fit/Parameters/FitSuiteParameters.h
-//! @brief     Declares class FitSuiteParameters.
+//! @brief     Defines class FitSuiteParameters.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Fit/RootWrapper/ROOTGeneticMinimizer.h b/Fit/RootWrapper/ROOTGeneticMinimizer.h
index 6a6706b64e70d6ec24815e8fcf48834058e66d7a..58136cc0f0afcca62683173991aadff83f541ce6 100644
--- a/Fit/RootWrapper/ROOTGeneticMinimizer.h
+++ b/Fit/RootWrapper/ROOTGeneticMinimizer.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Fit/RootWrapper/ROOTGeneticMinimizer.h
-//! @brief     Declares class ROOTGeneticMinimizer.
+//! @brief     Defines class ROOTGeneticMinimizer.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef ROOTGENETICMINIMIZER_H
 #define ROOTGENETICMINIMIZER_H
 
-#include "ROOTMinimizer.h" // inheriting from
+#include "ROOTMinimizer.h"
 #include "Math/GeneticMinimizer.h"
 
 //! @class ROOTGeneticMinimizer
diff --git a/Fit/RootWrapper/ROOTLMAMinimizer.h b/Fit/RootWrapper/ROOTLMAMinimizer.h
index 1f216c549bfb80598e0e3372cca3f5813f495269..32d6bdd6accf710d8dfa1a0ea332de11f88e9310 100644
--- a/Fit/RootWrapper/ROOTLMAMinimizer.h
+++ b/Fit/RootWrapper/ROOTLMAMinimizer.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Fit/RootWrapper/ROOTLMAMinimizer.h
-//! @brief     Declares class ROOTLMAMinimizer.
+//! @brief     Defines class ROOTLMAMinimizer.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Fit/RootWrapper/ROOTMinimizer.h b/Fit/RootWrapper/ROOTMinimizer.h
index 38f328ef9fe85577aecc06194a216589c278b45c..9afff96ddb407ff5a6c3d7c9d839f5d086050185 100644
--- a/Fit/RootWrapper/ROOTMinimizer.h
+++ b/Fit/RootWrapper/ROOTMinimizer.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Fit/RootWrapper/ROOTMinimizer.h
-//! @brief     Declares class ROOTMinimizer.
+//! @brief     Defines class ROOTMinimizer.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef ROOTMINIMIZER_H
 #define ROOTMINIMIZER_H
 
-#include "IMinimizer.h" // inheriting from
+#include "IMinimizer.h"
 #include "FitSuiteParameters.h"
 #include "MinimizerOptions.h"
 
diff --git a/Fit/RootWrapper/ROOTMinimizerFunction.h b/Fit/RootWrapper/ROOTMinimizerFunction.h
index 2bef928dd659f25391a7a174649f82df3e60d4a0..2ea15b29d3acc5d7043f4cd0b64a5133668a25d4 100644
--- a/Fit/RootWrapper/ROOTMinimizerFunction.h
+++ b/Fit/RootWrapper/ROOTMinimizerFunction.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Fit/RootWrapper/ROOTMinimizerFunction.h
-//! @brief     Declares classes ROOTMinimizerChiSquaredFunction and ROOTMinimizerGradientFunction
+//! @brief     Defines classes ROOTMinimizerChiSquaredFunction and ROOTMinimizerGradientFunction
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Fit/RootWrapper/ROOTMinimizerHelper.h b/Fit/RootWrapper/ROOTMinimizerHelper.h
index 295f29c3efa9897c5e26a4629e189048fef92f7b..d00980123474384e4c5815f546c4064d1809cfd5 100644
--- a/Fit/RootWrapper/ROOTMinimizerHelper.h
+++ b/Fit/RootWrapper/ROOTMinimizerHelper.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Fit/RootWrapper/ROOTMinimizerHelper.h
-//! @brief     Declares class ROOTMinimizerHelper.
+//! @brief     Defines class ROOTMinimizerHelper.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Fit/RootWrapper/ROOTMinuit2Minimizer.h b/Fit/RootWrapper/ROOTMinuit2Minimizer.h
index 5bee05f7a5b6135d82b77bc2b9bd6570683f641c..53878c30c10faef59c7539b6404b9bdecef60a85 100644
--- a/Fit/RootWrapper/ROOTMinuit2Minimizer.h
+++ b/Fit/RootWrapper/ROOTMinuit2Minimizer.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Fit/RootWrapper/ROOTMinuit2Minimizer.h
-//! @brief     Declares class ROOTMinuitMinimizer.
+//! @brief     Defines class ROOTMinuitMinimizer.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef ROOTMINUIT2MINIMIZER_H
 #define ROOTMINUIT2MINIMIZER_H
 
-#include "ROOTMinimizer.h" // inheriting from
+#include "ROOTMinimizer.h"
 #include "Minuit2/Minuit2Minimizer.h"
 
 //! @class ROOTMinuit2Minimizer
diff --git a/Fit/RootWrapper/ROOTMultiMinMinimizer.h b/Fit/RootWrapper/ROOTMultiMinMinimizer.h
index a5159082dbe63a480dd55fac984f5dfc07787143..4dd2c45060bd27e36b8abbd5eb0b2a8150b3b1e4 100644
--- a/Fit/RootWrapper/ROOTMultiMinMinimizer.h
+++ b/Fit/RootWrapper/ROOTMultiMinMinimizer.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Fit/RootWrapper/ROOTMultiMinMinimizer.h
-//! @brief     Declares class ROOTMultiMinMinimizer.
+//! @brief     Defines class ROOTMultiMinMinimizer.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Fit/RootWrapper/ROOTSimAnMinimizer.h b/Fit/RootWrapper/ROOTSimAnMinimizer.h
index 22b85f02225f0f7e3deac1f67b6957a3db1bf340..8088b99632063a6c5161cfd8098398d4e7c6c789 100644
--- a/Fit/RootWrapper/ROOTSimAnMinimizer.h
+++ b/Fit/RootWrapper/ROOTSimAnMinimizer.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Fit/RootWrapper/ROOTSimAnMinimizer.h
-//! @brief     Declares class ROOTSimAnMinimizer.
+//! @brief     Defines class ROOTSimAnMinimizer.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Fit/Utils/Logger.h b/Fit/Utils/Logger.h
index 9579bce9e57ce9f0387e61b9313103b304990942..e9adaf92c17895f69e5b2d3b3d1cde7fc4a9b98b 100644
--- a/Fit/Utils/Logger.h
+++ b/Fit/Utils/Logger.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Fit/Utils/Logger.h
-//! @brief     Declares MSG namespace and Logger class.
+//! @brief     Defines MSG namespace and Logger class.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Fit/Utils/Numeric.h b/Fit/Utils/Numeric.h
index 67ec255ad93c97e01ac009aace1101c98d50a60c..5e23b6ac7b06047088ba342a256193663303e64c 100644
--- a/Fit/Utils/Numeric.h
+++ b/Fit/Utils/Numeric.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Fit/Utils/Numeric.h
-//! @brief     Declares constants and "almost equal" in namespace Numeric.
+//! @brief     Defines constants and "almost equal" in namespace Numeric.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Fit/Utils/StringUtils.h b/Fit/Utils/StringUtils.h
index 52f65582d6294ef89d5db842152c17a527b12723..8075caf00ca08248a3c47d4bfc03c8218aac9fdf 100644
--- a/Fit/Utils/StringUtils.h
+++ b/Fit/Utils/StringUtils.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Fit/Utils/StringUtils.h
-//! @brief     Declares a few helper functions
+//! @brief     Defines a few helper functions
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Models/AngleProperty.cpp b/GUI/coregui/Models/AngleProperty.cpp
index 6561290078f336f97b7d81868dda1076260d9f62..0e9c1a1d9174486fbbea076ba692715b48428b21 100644
--- a/GUI/coregui/Models/AngleProperty.cpp
+++ b/GUI/coregui/Models/AngleProperty.cpp
@@ -51,18 +51,6 @@ AngleProperty::AngleProperty(double angle_value, const QString &angle_units)
 }
 
 
-//AngleProperty::AngleUnits AngleProperty::getUnits() const
-//{
-//    return m_angle_units;
-//}
-
-
-//void AngleProperty::setUnits(AngleUnits units)
-//{
-//    m_angle_units = units;
-//}
-
-
 QString AngleProperty::getUnits() const
 {
 //    return m_labels[m_angle_units];
diff --git a/GUI/coregui/Models/AngleProperty.h b/GUI/coregui/Models/AngleProperty.h
index 12a75378716ebde4d603c60cb74f6dab79ebd940..d961a8dbe7ee4b03c8496113d20565f0e1aeeed7 100644
--- a/GUI/coregui/Models/AngleProperty.h
+++ b/GUI/coregui/Models/AngleProperty.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/AngleProperty.h
-//! @brief     Declares class AngleProperty
+//! @brief     Defines class AngleProperty
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Models/ApplicationModels.h b/GUI/coregui/Models/ApplicationModels.h
index af22d32db7362958130915794f679281e1226534..3aaf990b38909948f033e9c9de4c417ad54b62db 100644
--- a/GUI/coregui/Models/ApplicationModels.h
+++ b/GUI/coregui/Models/ApplicationModels.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/ApplicationModels.h
-//! @brief     Declares class holding all application models
+//! @brief     Defines class holding all application models
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Models/AxesItems.h b/GUI/coregui/Models/AxesItems.h
index 5cabc065f288ca0ea8214c7bed7d9db59e076e0e..384a4950d49354af1ac50d12cb5559332c2b50f7 100644
--- a/GUI/coregui/Models/AxesItems.h
+++ b/GUI/coregui/Models/AxesItems.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/AxesItems.h
-//! @brief     Declares various axis items
+//! @brief     Defines various axis items
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef AXESITEMS_H
 #define AXESITEMS_H
 
-#include "SessionItem.h" // inheriting from
+#include "SessionItem.h"
 
 class BA_CORE_API_  BasicAxisItem : public SessionItem
 {
diff --git a/GUI/coregui/Models/BeamAngleItems.cpp b/GUI/coregui/Models/BeamAngleItems.cpp
index 2d948188d574958d2a7aba3bffd7e3c4ae73f431..21d291698d7c72f52257596352e9b8956fe03243 100644
--- a/GUI/coregui/Models/BeamAngleItems.cpp
+++ b/GUI/coregui/Models/BeamAngleItems.cpp
@@ -19,7 +19,6 @@
 #include "GUIHelpers.h"
 #include "Units.h"
 
-
 BeamInclinationAngleItem::BeamInclinationAngleItem()
     : BeamDistributionItem(Constants::BeamInclinationAngleType)
 {
diff --git a/GUI/coregui/Models/BeamAngleItems.h b/GUI/coregui/Models/BeamAngleItems.h
index 3cc0c9f55124acdec099e962e259da87f5dab0ab..21f69db25532aaf4c7d286cf2b5d43cf1c782e39 100644
--- a/GUI/coregui/Models/BeamAngleItems.h
+++ b/GUI/coregui/Models/BeamAngleItems.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/BeamAngleItems.h
-//! @brief     Declares class BeamAngleItems
+//! @brief     Defines class BeamAngleItems
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef BEAMANGLEITEMS_H
 #define BEAMANGLEITEMS_H
 
-#include "BeamDistributionItem.h" // inheriting from
+#include "BeamDistributionItem.h"
 
 class BA_CORE_API_ BeamAzimuthalAngleItem : public BeamDistributionItem
 {
diff --git a/GUI/coregui/Models/BeamDistributionItem.h b/GUI/coregui/Models/BeamDistributionItem.h
index af6248e6d6f0c76c0914519b2df9c02297b823b9..09fa8d67e6c33ca967c6b8e1d96d17ff9448252d 100644
--- a/GUI/coregui/Models/BeamDistributionItem.h
+++ b/GUI/coregui/Models/BeamDistributionItem.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/BeamDistributionItem.h
-//! @brief     Declares class BeamDistributionItem
+//! @brief     Defines class BeamDistributionItem
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Models/BeamItem.h b/GUI/coregui/Models/BeamItem.h
index c56934d482709779671cd9cc98a4b24719ad0f91..644a86bec44dddf73797ea869f02963b51d9e871 100644
--- a/GUI/coregui/Models/BeamItem.h
+++ b/GUI/coregui/Models/BeamItem.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/BeamItem.h
-//! @brief     Declares class BeamItem
+//! @brief     Defines class BeamItem
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef BEAMITEM_H
 #define BEAMITEM_H
 
-#include "SessionItem.h" // inheriting from
+#include "SessionItem.h"
 
 class BA_CORE_API_ BeamItem : public SessionItem
 {
diff --git a/GUI/coregui/Models/BeamWavelengthItem.h b/GUI/coregui/Models/BeamWavelengthItem.h
index c8e797d2d0e7fa296b7746dd40f62a4850a04a3f..879221a0558adb95ba15b145b293b3be9949e121 100644
--- a/GUI/coregui/Models/BeamWavelengthItem.h
+++ b/GUI/coregui/Models/BeamWavelengthItem.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/BeamWavelengthItem.h
-//! @brief     Declares class BeamWavelengthItem
+//! @brief     Defines class BeamWavelengthItem
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef BEAMWAVELENGTHITEM_H
 #define BEAMWAVELENGTHITEM_H
 
-#include "BeamDistributionItem.h" // inheriting from
+#include "BeamDistributionItem.h"
 
 class BA_CORE_API_ BeamWavelengthItem : public BeamDistributionItem
 {
diff --git a/GUI/coregui/Models/ColorProperty.h b/GUI/coregui/Models/ColorProperty.h
index 827b7d796e20eaa6aae5561cfdc5d9915d6ab263..c4adfd44b0d40dd9f7230facc18c8ed6aea9d953 100644
--- a/GUI/coregui/Models/ColorProperty.h
+++ b/GUI/coregui/Models/ColorProperty.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/ColorProperty.h
-//! @brief     Declares class ColorProperty
+//! @brief     Defines class ColorProperty
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Models/ComboProperty.h b/GUI/coregui/Models/ComboProperty.h
index 88d3e8153b39855c4f2a6ff92de85100bc5a4e0e..56c50a39d85501b8e28758cc1b28bf08b0fd8a11 100644
--- a/GUI/coregui/Models/ComboProperty.h
+++ b/GUI/coregui/Models/ComboProperty.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/ComboProperty.h
-//! @brief     Declares class ComboProperty
+//! @brief     Defines class ComboProperty
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Models/DetectorItems.h b/GUI/coregui/Models/DetectorItems.h
index cb7eb239a2d44e7ed15f8242b96de8badcb05841..b666c4d4bfec7411c58506a40e250241adba5261 100644
--- a/GUI/coregui/Models/DetectorItems.h
+++ b/GUI/coregui/Models/DetectorItems.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/DetectorItems.h
-//! @brief     Declares classes DetectorItems
+//! @brief     Defines classes DetectorItems
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Models/DistributionItem.h b/GUI/coregui/Models/DistributionItem.h
index a06325425e708608283516a004b7b0d05726a044..f20fd7b1e7e1e0aea804d97164fbae0fc2a2decc 100644
--- a/GUI/coregui/Models/DistributionItem.h
+++ b/GUI/coregui/Models/DistributionItem.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/DistributionItem.h
-//! @brief     Declares class DistributionItem and several subclasses
+//! @brief     Defines class DistributionItem and several subclasses
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef DISTRIBUTIONITEM_H
 #define DISTRIBUTIONITEM_H
 
-#include "SessionItem.h" // inheriting from
+#include "SessionItem.h"
 
 
 class IDistribution1D;
diff --git a/GUI/coregui/Models/DocumentModel.h b/GUI/coregui/Models/DocumentModel.h
index 5da559b4218b0f2534c1acde74a6cacb57212dbd..c4ee63c24f2c0fa6a130c6d589171662de7148a3 100644
--- a/GUI/coregui/Models/DocumentModel.h
+++ b/GUI/coregui/Models/DocumentModel.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/DocumentModel.h
-//! @brief     Declares class DocumentModel
+//! @brief     Defines class DocumentModel
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef DOCUMENTMODEL_H
 #define DOCUMENTMODEL_H
 
-#include "SessionModel.h" // inheriting from
+#include "SessionModel.h"
 
 class SimulationOptionsItem;
 
diff --git a/GUI/coregui/Models/DomainFittingBuilder.h b/GUI/coregui/Models/DomainFittingBuilder.h
index ea53aa63f09cf6cc72e2d41c7edc22f051cb9370..1dc558b43805ad0a56f88209c87f25da261aa101 100644
--- a/GUI/coregui/Models/DomainFittingBuilder.h
+++ b/GUI/coregui/Models/DomainFittingBuilder.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/DomainFittingBuilder.h
-//! @brief     Declares class DomainFittingBuilder
+//! @brief     Defines class DomainFittingBuilder
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Models/DomainObjectBuilder.h b/GUI/coregui/Models/DomainObjectBuilder.h
index 46c75e2ef6db37c31f2eb61c504e814cb09091a4..26ac0f23effb329a89a5f442b8d69a61dcf8ff89 100644
--- a/GUI/coregui/Models/DomainObjectBuilder.h
+++ b/GUI/coregui/Models/DomainObjectBuilder.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/DomainObjectBuilder.h
-//! @brief     Declares class DomainObjectBuilder
+//! @brief     Defines class DomainObjectBuilder
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Models/DomainSimulationBuilder.h b/GUI/coregui/Models/DomainSimulationBuilder.h
index e30292f992bd8bced13e03dfcdfdbd06cccecfe1..2680bb2d41718f8f2c83f42e7b368c957a3c99e0 100644
--- a/GUI/coregui/Models/DomainSimulationBuilder.h
+++ b/GUI/coregui/Models/DomainSimulationBuilder.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/DomainSimulationBuilder.h
-//! @brief     Declares class DomainSimulationBuilder
+//! @brief     Defines class DomainSimulationBuilder
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Models/FTDecayFunctionItems.h b/GUI/coregui/Models/FTDecayFunctionItems.h
index 3ab65ab3032e4eef47ce6b1acce5f417ab5cf8f6..893b4643a95235ea0d50068678003a7ae6776389 100644
--- a/GUI/coregui/Models/FTDecayFunctionItems.h
+++ b/GUI/coregui/Models/FTDecayFunctionItems.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/FTDecayFunctionItems.h
-//! @brief     Declares FTDecayFunction1DItem classes
+//! @brief     Defines FTDecayFunction1DItem classes
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -18,7 +18,7 @@
 #define FTDECAYFUNCTIONITEMS_H
 
 
-#include "SessionItem.h" // inheriting from
+#include "SessionItem.h"
 #include "FTDecayFunctions.h"
 
 
diff --git a/GUI/coregui/Models/FTDistributionItems.h b/GUI/coregui/Models/FTDistributionItems.h
index c4605646fa81900425305a32cd153301a0ac025b..3dccd4140b96cded9b4002c256dabe8ad9d109c3 100644
--- a/GUI/coregui/Models/FTDistributionItems.h
+++ b/GUI/coregui/Models/FTDistributionItems.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/FTDistributionItems.h
-//! @brief     Declares FTDistribution1DItem's classes
+//! @brief     Defines FTDistribution1DItem's classes
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -18,7 +18,7 @@
 #define FTDISTRIBUTIONITEMS_H
 
 
-#include "SessionItem.h" // inheriting from
+#include "SessionItem.h"
 #include "FTDistributions1D.h"
 #include "FTDistributions2D.h"
 
diff --git a/GUI/coregui/Models/FilterPropertyProxy.h b/GUI/coregui/Models/FilterPropertyProxy.h
index d6078d332f302875a4fd3c905c87a836362baefe..9a10a74b3f66c41c1de9730c291f14b22e66a5a5 100644
--- a/GUI/coregui/Models/FilterPropertyProxy.h
+++ b/GUI/coregui/Models/FilterPropertyProxy.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/FilterPropertyProxy.h
-//! @brief     Declares class FilterPropertyProxy
+//! @brief     Defines class FilterPropertyProxy
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Models/FitParameterHelper.h b/GUI/coregui/Models/FitParameterHelper.h
index acb68ab82e45d37728f672cb86a263aaa5d80ad3..40eaabe4361fb28b0bcd89acacb1d6dd682ae40d 100644
--- a/GUI/coregui/Models/FitParameterHelper.h
+++ b/GUI/coregui/Models/FitParameterHelper.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/FitParameterHelper.h
-//! @brief     Declares class FitParameterHelper
+//! @brief     Defines class FitParameterHelper
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Models/FitParameterItems.h b/GUI/coregui/Models/FitParameterItems.h
index 57267f20e0a905697805f1a2baa26babdbd9dd79..b3d227fffefac1c8cc51d65ab4d6fd5c71fc43a2 100644
--- a/GUI/coregui/Models/FitParameterItems.h
+++ b/GUI/coregui/Models/FitParameterItems.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/FitParameterItems.h
-//! @brief     Declares class FitParameterItems
+//! @brief     Defines class FitParameterItems
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef FITPARAMETERITEMS_H
 #define FITPARAMETERITEMS_H
 
-#include "SessionItem.h" // inheriting from
+#include "SessionItem.h"
 
 
 //! FitParameterItems is a collection of items to define fit parameters in GUI.
diff --git a/GUI/coregui/Models/FitParameterProxyModel.h b/GUI/coregui/Models/FitParameterProxyModel.h
index 8b44be0eb28ea70820ee2e4112763bd91742fb71..0be71929a9ef647498b6874b6028da1203baf928 100644
--- a/GUI/coregui/Models/FitParameterProxyModel.h
+++ b/GUI/coregui/Models/FitParameterProxyModel.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/FitParameterProxyModel.h
-//! @brief     Declares class FitParameterProxyModel
+//! @brief     Defines class FitParameterProxyModel
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Models/FitSuiteItem.h b/GUI/coregui/Models/FitSuiteItem.h
index 8b93fcc9ee33e79b759b89c3c5fdbe2607df5b3f..0aca440339bf35121cdd2ae87061396c658144f8 100644
--- a/GUI/coregui/Models/FitSuiteItem.h
+++ b/GUI/coregui/Models/FitSuiteItem.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/FitSuiteItem.h
-//! @brief     Declares class FitSuiteItem
+//! @brief     Defines class FitSuiteItem
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef FITSUITEITEM_H
 #define FITSUITEITEM_H
 
-#include "SessionItem.h" // inheriting from
+#include "SessionItem.h"
 
 class FitParameterContainerItem;
 class MinimizerContainerItem;
diff --git a/GUI/coregui/Models/FormFactorItems.h b/GUI/coregui/Models/FormFactorItems.h
index fcfb7b6c568f6acfe886e94867c73958b716b59d..5e3b190cc6ef0aa72e06b30a94514896f37fc03b 100644
--- a/GUI/coregui/Models/FormFactorItems.h
+++ b/GUI/coregui/Models/FormFactorItems.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/FormFactorItems.h
-//! @brief     Declares FormFactorItems classes
+//! @brief     Defines FormFactorItems classes
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef FORMFACTORITEMS_H
 #define FORMFACTORITEMS_H
 
-#include "SessionItem.h" // inheriting from
+#include "SessionItem.h"
 
 
 class IFormFactor;
diff --git a/GUI/coregui/Models/GUIExamplesFactory.h b/GUI/coregui/Models/GUIExamplesFactory.h
index 531de30c06c535cbef6a448ce157bdecd2a149fb..cbd906ccbb146c48a2d7c4044760259a75eb1a64 100644
--- a/GUI/coregui/Models/GUIExamplesFactory.h
+++ b/GUI/coregui/Models/GUIExamplesFactory.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/GUIExamplesFactory.h
-//! @brief     Declares class GUIExamplesFactory
+//! @brief     Defines class GUIExamplesFactory
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Models/GUIObjectBuilder.h b/GUI/coregui/Models/GUIObjectBuilder.h
index 8efde7995b4d551073c7e47512737ccf5a6aefcb..82fee163227b9e601d1e318a0929117ea83ea0bd 100644
--- a/GUI/coregui/Models/GUIObjectBuilder.h
+++ b/GUI/coregui/Models/GUIObjectBuilder.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/GUIObjectBuilder.h
-//! @brief     Declares class GUIObjectBuilder
+//! @brief     Defines class GUIObjectBuilder
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef GUIOBJECTBUILDER_H
 #define GUIOBJECTBUILDER_H
 
-#include "ISampleVisitor.h" // inheriting from
+#include "ISampleVisitor.h"
 #include "MaterialProperty.h"
 
 class IMaterial;
diff --git a/GUI/coregui/Models/GroupItem.h b/GUI/coregui/Models/GroupItem.h
index 993f7787be658bc07068371d57d0ff9d3e4e2a0c..c1723f65d99dd1cf6982ed4db079e27265a24972 100644
--- a/GUI/coregui/Models/GroupItem.h
+++ b/GUI/coregui/Models/GroupItem.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/GroupItem.h
-//! @brief     Declares class GroupItem
+//! @brief     Defines class GroupItem
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef GROUPITEM_H
 #define GROUPITEM_H
 
-#include "SessionItem.h" // inheriting from
+#include "SessionItem.h"
 #include "GroupProperty.h"
 
 class BA_CORE_API_ GroupItem : public SessionItem
diff --git a/GUI/coregui/Models/GroupProperty.h b/GUI/coregui/Models/GroupProperty.h
index 1ce1987ee15431915fe78f151b9bab17a6f22c04..66bf5289feede0638d1ec965db2afec4257cff1f 100644
--- a/GUI/coregui/Models/GroupProperty.h
+++ b/GUI/coregui/Models/GroupProperty.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/GroupProperty.h
-//! @brief     Declares class GroupProperty
+//! @brief     Defines class GroupProperty
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Models/GroupPropertyRegistry.h b/GUI/coregui/Models/GroupPropertyRegistry.h
index 8e3c9941859fc5f8012b9dff56e968267b95816a..4094b760d5fec8b21379ec146906fd76979c8202 100644
--- a/GUI/coregui/Models/GroupPropertyRegistry.h
+++ b/GUI/coregui/Models/GroupPropertyRegistry.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/GroupPropertyRegistry.h
-//! @brief     Declares class GroupPropertyRegistry
+//! @brief     Defines class GroupPropertyRegistry
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Models/IconProvider.h b/GUI/coregui/Models/IconProvider.h
index 2321a01c481c398bb9f259cd49c0613fc7fd714c..7a54fc24ecd8ff1df5729d76975477b01ab880a7 100644
--- a/GUI/coregui/Models/IconProvider.h
+++ b/GUI/coregui/Models/IconProvider.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/IconProvider.h
-//! @brief     Declares class IconProvider
+//! @brief     Defines class IconProvider
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Models/InstrumentItem.h b/GUI/coregui/Models/InstrumentItem.h
index 9db97fda9fddfbe466d690137e04b7a7829312c2..0d7d0a51fa32af6d4c21d94d8752342204df7885 100644
--- a/GUI/coregui/Models/InstrumentItem.h
+++ b/GUI/coregui/Models/InstrumentItem.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/InstrumentItem.h
-//! @brief     Declares class InstrumentItem
+//! @brief     Defines class InstrumentItem
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef INSTRUMENTITEM_H
 #define INSTRUMENTITEM_H
 
-#include "SessionItem.h" // inheriting from
+#include "SessionItem.h"
 
 class BeamItem;
 class DetectorItem;
diff --git a/GUI/coregui/Models/InstrumentModel.h b/GUI/coregui/Models/InstrumentModel.h
index 8cd0f5f6da1cf006c58997e280b38ce867ca453d..d5df3c9b4e6ca7ae755b4e3481eed13c822fab77 100644
--- a/GUI/coregui/Models/InstrumentModel.h
+++ b/GUI/coregui/Models/InstrumentModel.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/InstrumentModel.h
-//! @brief     Declares class InstrumentModel
+//! @brief     Defines class InstrumentModel
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef INSTRUMENTMODEL_H
 #define INSTRUMENTMODEL_H
 
-#include "SessionModel.h" // inheriting from
+#include "SessionModel.h"
 
 class InstrumentItem;
 
diff --git a/GUI/coregui/Models/IntensityDataItem.h b/GUI/coregui/Models/IntensityDataItem.h
index 18f3e1f9f87f3e64ae26756c266b7cad17e5de26..bd81f7322708da20e6f6002c82bb27c7a6fa807d 100644
--- a/GUI/coregui/Models/IntensityDataItem.h
+++ b/GUI/coregui/Models/IntensityDataItem.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/IntensityDataItem.h
-//! @brief     Declares class IntensityDataItem
+//! @brief     Defines class IntensityDataItem
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef INTENSITYDATAITEM_H
 #define INTENSITYDATAITEM_H
 
-#include "SessionItem.h" // inheriting from
+#include "SessionItem.h"
 #include "IDetector2D.h"
 
 class BasicAxisItem;
diff --git a/GUI/coregui/Models/InterferenceFunctionItems.cpp b/GUI/coregui/Models/InterferenceFunctionItems.cpp
index 3ff2c14831e81fd124e9da5546b835a2c5da211f..a43c283c87291493b4a859e515e4c9e90e76c9be 100644
--- a/GUI/coregui/Models/InterferenceFunctionItems.cpp
+++ b/GUI/coregui/Models/InterferenceFunctionItems.cpp
@@ -18,7 +18,6 @@
 #include "BornAgainNamespace.h"
 #include "Units.h"
 
-
 const QString InterferenceFunctionRadialParaCrystalItem::P_PEAK_DISTANCE =
         QString::fromStdString(BornAgain::PeakDistance);
 const QString InterferenceFunctionRadialParaCrystalItem::P_DAMPING_LENGTH =
diff --git a/GUI/coregui/Models/InterferenceFunctionItems.h b/GUI/coregui/Models/InterferenceFunctionItems.h
index 6020567dfe835cc4b4ef1ccf4fabe42b13f43a59..78c0736b1bc2eed7e12cac7d773685a353ebff88 100644
--- a/GUI/coregui/Models/InterferenceFunctionItems.h
+++ b/GUI/coregui/Models/InterferenceFunctionItems.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/InterferenceFunctionItems.h
-//! @brief     Declares InterferenceFunctionItems's classes
+//! @brief     Defines InterferenceFunctionItems's classes
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef INTERFERENCEFUNCTIONITEMS_H
 #define INTERFERENCEFUNCTIONITEMS_H
 
-#include "SessionGraphicsItem.h" // inheriting from
+#include "SessionGraphicsItem.h"
 
 
 class BA_CORE_API_ InterferenceFunctionRadialParaCrystalItem : public SessionGraphicsItem
diff --git a/GUI/coregui/Models/ItemFactory.h b/GUI/coregui/Models/ItemFactory.h
index ded70ef05d766950744a4f862fb2cc71b2224c87..747a408196ba78884e91f1fad9779719280c0780 100644
--- a/GUI/coregui/Models/ItemFactory.h
+++ b/GUI/coregui/Models/ItemFactory.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/ItemFactory.h
-//! @brief     Declares class ItemFactory
+//! @brief     Defines class ItemFactory
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Models/JobItem.h b/GUI/coregui/Models/JobItem.h
index e9ce7109c7390fe1af1d7f05dd152cf02fea0f58..528e19c3ff7b5c7527f3cafa4c0f709567ba2594 100644
--- a/GUI/coregui/Models/JobItem.h
+++ b/GUI/coregui/Models/JobItem.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/JobItem.h
-//! @brief     Declares class JobItem
+//! @brief     Defines class JobItem
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef JOBITEM_H
 #define JOBITEM_H
 
-#include "SessionItem.h" // inheriting from
+#include "SessionItem.h"
 class IntensityDataItem;
 class GISASSimulation;
 class MultiLayerItem;
diff --git a/GUI/coregui/Models/JobItemHelper.h b/GUI/coregui/Models/JobItemHelper.h
index a4e35c80acb8b823b62b25e820534d6868e644e6..c452b0d2d16ba677aa13d2b623f6171a27ce60ee 100644
--- a/GUI/coregui/Models/JobItemHelper.h
+++ b/GUI/coregui/Models/JobItemHelper.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/JobItemHelper.h
-//! @brief     Declares class JobItemHelper
+//! @brief     Defines class JobItemHelper
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Models/JobModel.h b/GUI/coregui/Models/JobModel.h
index f452b564cf913c47b6f75ba2b7a1902ba476130c..a66c51b2e287e1ac5fdf1ed0282b81b6f558aae1 100644
--- a/GUI/coregui/Models/JobModel.h
+++ b/GUI/coregui/Models/JobModel.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/JobModel.h
-//! @brief     Declares class JobModel
+//! @brief     Defines class JobModel
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef JOBMODEL_H
 #define JOBMODEL_H
 
-#include "SessionModel.h" // inheriting from
+#include "SessionModel.h"
 class JobQueueData;
 class JobItem;
 class MultiLayerItem;
diff --git a/GUI/coregui/Models/JobQueueData.h b/GUI/coregui/Models/JobQueueData.h
index a12986ea5c0369979cf4518185396d3da3a62269..5cebf0cc15c64a38ba09049f19a49d4794940b87 100644
--- a/GUI/coregui/Models/JobQueueData.h
+++ b/GUI/coregui/Models/JobQueueData.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/JobQueueData.h
-//! @brief     Declares class JobQueueData
+//! @brief     Defines class JobQueueData
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Models/JobWorker.h b/GUI/coregui/Models/JobWorker.h
index 28a5bdd5d9a9877b2a645d218fe624b9f5127b73..941c7a53c3d2f6802c2900322e1b3cada35da7de 100644
--- a/GUI/coregui/Models/JobWorker.h
+++ b/GUI/coregui/Models/JobWorker.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/JobWorker.h
-//! @brief     Declares class JobWorker
+//! @brief     Defines class JobWorker
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Models/LatticeTypeItems.h b/GUI/coregui/Models/LatticeTypeItems.h
index 215eff61c1d775ce647016ad4d180c18b7a1f315..2494162a8f4522f52e24c497adf96c1bfd306e03 100644
--- a/GUI/coregui/Models/LatticeTypeItems.h
+++ b/GUI/coregui/Models/LatticeTypeItems.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/LatticeTypeItems.h
-//! @brief     Declares classes LatticeTypeItems
+//! @brief     Defines classes LatticeTypeItems
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef LATTICETYPEITEMS_H
 #define LATTICETYPEITEMS_H
 
-#include "SessionItem.h" // inheriting from
+#include "SessionItem.h"
 
 class BA_CORE_API_ BasicLatticeTypeItem : public SessionItem
 {
diff --git a/GUI/coregui/Models/LayerItem.h b/GUI/coregui/Models/LayerItem.h
index 0505cf24531cb5aa11be4cc37d70dec7f308102d..a61767cf6ee9ea2001f7fec7886045818f72b6d2 100644
--- a/GUI/coregui/Models/LayerItem.h
+++ b/GUI/coregui/Models/LayerItem.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/LayerItem.h
-//! @brief     Declares class LayerItem
+//! @brief     Defines class LayerItem
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef LAYERITEM_H
 #define LAYERITEM_H
 
-#include "SessionGraphicsItem.h" // inheriting from
+#include "SessionGraphicsItem.h"
 
 class BA_CORE_API_ LayerItem : public SessionGraphicsItem
 {
diff --git a/GUI/coregui/Models/LayerRoughnessItems.h b/GUI/coregui/Models/LayerRoughnessItems.h
index 3d0c6beab06d6695331aa3e1f8456e6d22c1f648..4fa465763110f50e4d5557cfe2a200223e3560c8 100644
--- a/GUI/coregui/Models/LayerRoughnessItems.h
+++ b/GUI/coregui/Models/LayerRoughnessItems.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/LayerRoughnessItems.h
-//! @brief     Declares classes LayerRoughnessItems
+//! @brief     Defines classes LayerRoughnessItems
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -18,7 +18,7 @@
 #define LAYERROUGHNESSITEMS_H
 
 
-#include "SessionItem.h" // inheriting from
+#include "SessionItem.h"
 
 class BA_CORE_API_ LayerZeroRoughnessItem : public SessionItem
 {
diff --git a/GUI/coregui/Models/MagneticFieldItem.h b/GUI/coregui/Models/MagneticFieldItem.h
index 5574435640ca1287e6fbf6cb53371770c682a3aa..9146ab8210856c0187b3bf866ec119db2d27aa7d 100644
--- a/GUI/coregui/Models/MagneticFieldItem.h
+++ b/GUI/coregui/Models/MagneticFieldItem.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/MagneticFieldItem.h
-//! @brief     Declares class MagneticFieldItem
+//! @brief     Defines class MagneticFieldItem
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -18,7 +18,7 @@
 #define MAGNETICFIELDITEM_H
 
 
-#include "SessionItem.h" // inheriting from
+#include "SessionItem.h"
 
 class BA_CORE_API_ MagneticFieldItem : public SessionItem
 {
diff --git a/GUI/coregui/Models/MaskItems.h b/GUI/coregui/Models/MaskItems.h
index 1e9ad799ef956b46a9a100d7d1b41245f28c77c8..430b2158526c9ddc9764404608a9bbaff1287491 100644
--- a/GUI/coregui/Models/MaskItems.h
+++ b/GUI/coregui/Models/MaskItems.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/MaskItems.h
-//! @brief     Declares MaskItems classes
+//! @brief     Defines MaskItems classes
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef MASKITEMS_H
 #define MASKITEMS_H
 
-#include "SessionItem.h" // inheriting from
+#include "SessionItem.h"
 
 namespace Geometry {
 class IShape2D;
diff --git a/GUI/coregui/Models/MaskModel.h b/GUI/coregui/Models/MaskModel.h
index 91ea24ce1c3c8980231b9a9acf7b713b8a140ccb..c48c5f8ae1458a81693deb83a761df2e52d2dd7b 100644
--- a/GUI/coregui/Models/MaskModel.h
+++ b/GUI/coregui/Models/MaskModel.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/MaskModel.h
-//! @brief     Declares MaskModel classes
+//! @brief     Defines MaskModel classes
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef MASKMODEL_H
 #define MASKMODEL_H
 
-#include "SessionModel.h" // inheriting from
+#include "SessionModel.h"
 
 class BA_CORE_API_ MaskModel : public SessionModel
 {
diff --git a/GUI/coregui/Models/MaterialItem.h b/GUI/coregui/Models/MaterialItem.h
index 893064937ac6e15a5c318dce8af5b6061e6d3ad2..f5602425115a8bd040a981ef7835ed25ff960a8e 100644
--- a/GUI/coregui/Models/MaterialItem.h
+++ b/GUI/coregui/Models/MaterialItem.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/MaterialItem.h
-//! @brief     Declares class MaterialItem
+//! @brief     Defines class MaterialItem
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef MATERIALITEM_H
 #define MATERIALITEM_H
 
-#include "SessionItem.h" // inheriting from
+#include "SessionItem.h"
 
 class IMaterial;
 
diff --git a/GUI/coregui/Models/MaterialModel.h b/GUI/coregui/Models/MaterialModel.h
index 031c01bc7ad81021e94a05aa7520063bec2bac72..8ec3abb194070cfad6dbe75f32407844c13f438e 100644
--- a/GUI/coregui/Models/MaterialModel.h
+++ b/GUI/coregui/Models/MaterialModel.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/MaterialModel.h
-//! @brief     Declares class MaterialModel
+//! @brief     Defines class MaterialModel
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef MATERIALMODEL_H
 #define MATERIALMODEL_H
 
-#include "SessionModel.h" // inheriting from
+#include "SessionModel.h"
 
 class MaterialItem;
 class MaterialProperty;
diff --git a/GUI/coregui/Models/MinimizerItem.h b/GUI/coregui/Models/MinimizerItem.h
index 20adda1a3ece2329919df3c6c0e7dbcf5fd93577..4a98edfc92205946eecbd63c1d7d336aaca93293 100644
--- a/GUI/coregui/Models/MinimizerItem.h
+++ b/GUI/coregui/Models/MinimizerItem.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/MinimizerItem.h
-//! @brief     Declares MinimizerItem class
+//! @brief     Defines MinimizerItem class
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef MINIMIZERITEM_H
 #define MINIMIZERITEM_H
 
-#include "SessionItem.h" // inheriting from
+#include "SessionItem.h"
 
 class IMinimizer;
 
diff --git a/GUI/coregui/Models/MinimizerItemCatalogue.h b/GUI/coregui/Models/MinimizerItemCatalogue.h
index 1e1a90434c7a9afc37cf24e53ddddcb6e1f22aad..8da8c0673397968eb23db5960d3ba75b0bcbaf72 100644
--- a/GUI/coregui/Models/MinimizerItemCatalogue.h
+++ b/GUI/coregui/Models/MinimizerItemCatalogue.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/MinimizerItemCatalogue.h
-//! @brief     Declares MinimizerItemCatalogue class
+//! @brief     Defines MinimizerItemCatalogue class
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Models/ModelMapper.h b/GUI/coregui/Models/ModelMapper.h
index 9bff42f13fef847ea426671ffae367a5d394b9bc..2d48476af14491918c83e4054f70104730dc34cf 100644
--- a/GUI/coregui/Models/ModelMapper.h
+++ b/GUI/coregui/Models/ModelMapper.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/ModelMapper.h
-//! @brief     Declares class ModelMapper
+//! @brief     Defines class ModelMapper
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Models/ModelPath.h b/GUI/coregui/Models/ModelPath.h
index 6a44dc97c05a735ffa90470424fa4466819ab31a..a91a7c81b7fcbcce3bf7fc27cef51a658fc415cd 100644
--- a/GUI/coregui/Models/ModelPath.h
+++ b/GUI/coregui/Models/ModelPath.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/ModelPath.h
-//! @brief     Declares class ModelPath
+//! @brief     Defines class ModelPath
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Models/MultiLayerItem.h b/GUI/coregui/Models/MultiLayerItem.h
index 2c61ab96170c40d5bf09efdb88175c4a11a919d4..797e2a100f028a765220af79216a31d6e2d5068a 100644
--- a/GUI/coregui/Models/MultiLayerItem.h
+++ b/GUI/coregui/Models/MultiLayerItem.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/MultiLayerItem.h
-//! @brief     Declares class MultiLayerItem
+//! @brief     Defines class MultiLayerItem
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef MULTILAYERITEM_H
 #define MULTILAYERITEM_H
 
-#include "SessionGraphicsItem.h" // inheriting from
+#include "SessionGraphicsItem.h"
 
 class BA_CORE_API_ MultiLayerItem : public SessionGraphicsItem
 {
diff --git a/GUI/coregui/Models/ParameterTranslators.h b/GUI/coregui/Models/ParameterTranslators.h
index 769d7db4e0dae045f9f5dd0e5f1380a19cdaf407..b331368b6c4abd51fc19263f0bee6265b27756ab 100644
--- a/GUI/coregui/Models/ParameterTranslators.h
+++ b/GUI/coregui/Models/ParameterTranslators.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/ParameterTranslators.h
-//! @brief     Declares interface IParameterTranslator and subclasses
+//! @brief     Defines interface IParameterTranslator and subclasses
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Models/ParameterTreeBuilder.h b/GUI/coregui/Models/ParameterTreeBuilder.h
index c1c874b5a75556fbf93596fd731ecffb56c192de..8e7c5f508c98f0c6cb621e3874a4d0335dad4977 100644
--- a/GUI/coregui/Models/ParameterTreeBuilder.h
+++ b/GUI/coregui/Models/ParameterTreeBuilder.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/ParameterTreeBuilder.h
-//! @brief     Declares class ParameterTreeBuilder
+//! @brief     Defines class ParameterTreeBuilder
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Models/ParameterTreeItems.h b/GUI/coregui/Models/ParameterTreeItems.h
index ecc24b40972ed519777a61550d99cc3c5d23411a..da41ac9694384cedbb29d357c3d43b677950c5e3 100644
--- a/GUI/coregui/Models/ParameterTreeItems.h
+++ b/GUI/coregui/Models/ParameterTreeItems.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/ParameterTreeItems.h
-//! @brief     Declares classes for ParameterTreeItems
+//! @brief     Defines classes for ParameterTreeItems
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef PARAMETERTREEITEMS_H
 #define PARAMETERTREEITEMS_H
 
-#include "SessionItem.h" // inheriting from
+#include "SessionItem.h"
 
 //! ParameterTreeItems is a collection of items necessary to form a tuning tree for
 //! real time widget.
diff --git a/GUI/coregui/Models/ParameterTuningModel.h b/GUI/coregui/Models/ParameterTuningModel.h
index 06dd943715e3c4a2597c4b9bbdfaeb5bedf181ee..eeeb3424c55258893469438e20576ca0534cf931 100644
--- a/GUI/coregui/Models/ParameterTuningModel.h
+++ b/GUI/coregui/Models/ParameterTuningModel.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/ParameterTuningModel.h
-//! @brief     Declares class ParameterTuningModel
+//! @brief     Defines class ParameterTuningModel
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef PARAMETERTUNINGMODEL_H
 #define PARAMETERTUNINGMODEL_H
 
-#include "FilterPropertyProxy.h" // inheriting from
+#include "FilterPropertyProxy.h"
 
 class ParameterItem;
 
diff --git a/GUI/coregui/Models/ParticleCompositionItem.h b/GUI/coregui/Models/ParticleCompositionItem.h
index ba2b847bdf7fbb79c2f82c98e21fe268e1948f1f..bef6c36691c2f1438ee58b778fd4c320936f9661 100644
--- a/GUI/coregui/Models/ParticleCompositionItem.h
+++ b/GUI/coregui/Models/ParticleCompositionItem.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/ParticleCompositionItem.h
-//! @brief     Declares class ParticleCompositionItem
+//! @brief     Defines class ParticleCompositionItem
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef PARTICLECOMPOSITIONITEM_H
 #define PARTICLECOMPOSITIONITEM_H
 
-#include "SessionGraphicsItem.h" // inheriting from
+#include "SessionGraphicsItem.h"
 #include "ParticleComposition.h"
 
 
diff --git a/GUI/coregui/Models/ParticleCoreShellItem.h b/GUI/coregui/Models/ParticleCoreShellItem.h
index 57b6e7919a0b9f43032173381bc06bb6b591182d..c833a9d799bb0bfdeb48f90d5dfa93816350993b 100644
--- a/GUI/coregui/Models/ParticleCoreShellItem.h
+++ b/GUI/coregui/Models/ParticleCoreShellItem.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/ParticleCoreShellItem.h
-//! @brief     Declares class ParticleCoreShellItem
+//! @brief     Defines class ParticleCoreShellItem
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef PARTICLECORESHELLITEM_H
 #define PARTICLECORESHELLITEM_H
 
-#include "SessionGraphicsItem.h" // inheriting from
+#include "SessionGraphicsItem.h"
 #include "ParticleCoreShell.h"
 
 
diff --git a/GUI/coregui/Models/ParticleDistributionItem.h b/GUI/coregui/Models/ParticleDistributionItem.h
index 9b197bc04d02b0d084eaf79210dfc7245749ebe7..82c91b65c0c915dd521cf63b4aaeb5056546edc3 100644
--- a/GUI/coregui/Models/ParticleDistributionItem.h
+++ b/GUI/coregui/Models/ParticleDistributionItem.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/ParticleDistributionItem.h
-//! @brief     Declares class ParticleDistributionItem
+//! @brief     Defines class ParticleDistributionItem
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef PARTICLEDISTRIBUTIONITEM_H
 #define PARTICLEDISTRIBUTIONITEM_H
 
-#include "SessionGraphicsItem.h" // inheriting from
+#include "SessionGraphicsItem.h"
 #include "ParticleDistribution.h"
 
 
diff --git a/GUI/coregui/Models/ParticleItem.h b/GUI/coregui/Models/ParticleItem.h
index cb87d3f2362532dac6bcfda59c505ed435dc5a99..66ab6c3035dc3481321d30b7b1e1bf3252f2f664 100644
--- a/GUI/coregui/Models/ParticleItem.h
+++ b/GUI/coregui/Models/ParticleItem.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/ParticleItem.h
-//! @brief     Declares class ParticleItem
+//! @brief     Defines class ParticleItem
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef PARTICLEITEM_H
 #define PARTICLEITEM_H
 
-#include "SessionGraphicsItem.h" // inheriting from
+#include "SessionGraphicsItem.h"
 #include "Particle.h"
 
 
diff --git a/GUI/coregui/Models/ParticleLayoutItem.h b/GUI/coregui/Models/ParticleLayoutItem.h
index a4ca92411ec5eb88b2e0add52678defe2a82a8ea..8b2b234ca12b63c32656936c7a24916108193ace 100644
--- a/GUI/coregui/Models/ParticleLayoutItem.h
+++ b/GUI/coregui/Models/ParticleLayoutItem.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/ParticleLayoutItem.h
-//! @brief     Declares class ParticleLayoutItem
+//! @brief     Defines class ParticleLayoutItem
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef PARTICLELAYOUTITEM_H
 #define PARTICLELAYOUTITEM_H
 
-#include "SessionGraphicsItem.h" // inheriting from
+#include "SessionGraphicsItem.h"
 
 class BA_CORE_API_ ParticleLayoutItem : public SessionGraphicsItem
 {
diff --git a/GUI/coregui/Models/PropertyAttribute.h b/GUI/coregui/Models/PropertyAttribute.h
index 410876de40c83ed0e80c4878ff8d139f9fbca145..27c48b1055098eda82ff7a134ab9f8c8d2db145d 100644
--- a/GUI/coregui/Models/PropertyAttribute.h
+++ b/GUI/coregui/Models/PropertyAttribute.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/PropertyAttribute.h
-//! @brief     Declares class PropertyAttribute
+//! @brief     Defines class PropertyAttribute
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Models/PropertyItem.h b/GUI/coregui/Models/PropertyItem.h
index 27ad175640cb11ddb5bb97befb6654396a479d78..2978f4ff6a39ac0e3e9209f31e234212fdd6dde8 100644
--- a/GUI/coregui/Models/PropertyItem.h
+++ b/GUI/coregui/Models/PropertyItem.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/PropertyItem.h
-//! @brief     Declares class PropertyItem
+//! @brief     Defines class PropertyItem
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef PROPERTYITEM_H
 #define PROPERTYITEM_H
 
-#include "SessionItem.h" // inheriting from
+#include "SessionItem.h"
 
 class BA_CORE_API_ PropertyItem : public SessionItem
 {
diff --git a/GUI/coregui/Models/RealDataItem.h b/GUI/coregui/Models/RealDataItem.h
index 4dc3d15dbd9dad472d75b4ce8d1f2d50ed3fc832..03d13c9db892ff14e10815eeee74b2b0d1a542e3 100644
--- a/GUI/coregui/Models/RealDataItem.h
+++ b/GUI/coregui/Models/RealDataItem.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/RealDataItem.h
-//! @brief     Declares class RealDataItem
+//! @brief     Defines class RealDataItem
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef REALDATAITEM_H
 #define REALDATAITEM_H
 
-#include "SessionItem.h" // inheriting from
+#include "SessionItem.h"
 
 class IntensityDataItem;
 
diff --git a/GUI/coregui/Models/RealDataModel.h b/GUI/coregui/Models/RealDataModel.h
index 7208f7abbe345b9289d300d95c0361978bde7096..0d03a8b8fe2439e1a4fa4f1ef0dde0d429f8d02d 100644
--- a/GUI/coregui/Models/RealDataModel.h
+++ b/GUI/coregui/Models/RealDataModel.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/RealDataModel.h
-//! @brief     Declares class RealDataModel
+//! @brief     Defines class RealDataModel
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef REALDATAMODEL_H
 #define REALDATAMODEL_H
 
-#include "SessionModel.h" // inheriting from
+#include "SessionModel.h"
 
 //! The RealDataModel class is a model to store all imported RealDataItem's.
 
diff --git a/GUI/coregui/Models/RectangularDetectorItem.h b/GUI/coregui/Models/RectangularDetectorItem.h
index 0abc0257f6e4f0471665139090feee699c131edf..bc21b960b933899f355a150dfa5c4454d5ea6ac2 100644
--- a/GUI/coregui/Models/RectangularDetectorItem.h
+++ b/GUI/coregui/Models/RectangularDetectorItem.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/RectangularDetectorItem.h
-//! @brief     Declares class RectangularDetectorItem
+//! @brief     Defines class RectangularDetectorItem
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef RECTANGULARDETECTORITEM_H
 #define RECTANGULARDETECTORITEM_H
 
-#include "SessionItem.h" // inheriting from
+#include "SessionItem.h"
 #include "Vectors3D.h"
 
 class IDetector2D;
diff --git a/GUI/coregui/Models/RefractiveIndexItem.h b/GUI/coregui/Models/RefractiveIndexItem.h
index 866db9f028e05fd51ab0c4f0e2d5c1ac0d0a225b..13a02f98c0c97b616e8644f436f95c68c362d0c1 100644
--- a/GUI/coregui/Models/RefractiveIndexItem.h
+++ b/GUI/coregui/Models/RefractiveIndexItem.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/RefractiveIndexItem.h
-//! @brief     Declares class RefractiveIndexItem
+//! @brief     Defines class RefractiveIndexItem
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef REFRACTIVEINDEXITEM_H
 #define REFRACTIVEINDEXITEM_H
 
-#include "SessionItem.h" // inheriting from
+#include "SessionItem.h"
 
 class BA_CORE_API_ RefractiveIndexItem : public SessionItem
 {
diff --git a/GUI/coregui/Models/ResolutionFunctionItems.h b/GUI/coregui/Models/ResolutionFunctionItems.h
index e2c40c9998a6409754481529ce2fe33956604712..a2f0cb2a3e7a1f8e7354500630e13018908a78f6 100644
--- a/GUI/coregui/Models/ResolutionFunctionItems.h
+++ b/GUI/coregui/Models/ResolutionFunctionItems.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/ResolutionFunctionItems.h
-//! @brief     Declares family of ResolutionFunctionItem
+//! @brief     Defines family of ResolutionFunctionItem
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef RESOLUTIONFUNCTIONITEMS_H
 #define RESOLUTIONFUNCTIONITEMS_H
 
-#include "SessionItem.h" // inheriting from
+#include "SessionItem.h"
 #include "ResolutionFunction2DGaussian.h"
 
 
diff --git a/GUI/coregui/Models/RotationItems.h b/GUI/coregui/Models/RotationItems.h
index 2c6d34838c4716462846174eb41338be8c3cdcd0..8413cbe7cdf6cfac7057c0ca304309d0120fe53c 100644
--- a/GUI/coregui/Models/RotationItems.h
+++ b/GUI/coregui/Models/RotationItems.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/RotationItems.h
-//! @brief     Declares class RotationItems
+//! @brief     Defines class RotationItems
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef ROTATIONITEMS_H
 #define ROTATIONITEMS_H
 
-#include "SessionItem.h" // inheriting from
+#include "SessionItem.h"
 #include "Rotations.h"
 
 class RotationItem : public SessionItem
diff --git a/GUI/coregui/Models/SampleModel.h b/GUI/coregui/Models/SampleModel.h
index 229c107141adc911f187e38533c6ddf7fc465421..01962d6017bb13062d655a29927c6ca409dd580e 100644
--- a/GUI/coregui/Models/SampleModel.h
+++ b/GUI/coregui/Models/SampleModel.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/SampleModel.h
-//! @brief     Declares class SampleModel
+//! @brief     Defines class SampleModel
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef SAMPLEMODEL_H
 #define SAMPLEMODEL_H
 
-#include "SessionModel.h" // inheriting from
+#include "SessionModel.h"
 
 class MultiLayerItem;
 class BA_CORE_API_ SampleModel : public SessionModel
diff --git a/GUI/coregui/Models/SampleValidator.h b/GUI/coregui/Models/SampleValidator.h
index 7c9de05e8b617867bbcf3cb5edf439d51ef51821..01a3a716624c24195d794d81ee1d041f2d6fa81d 100644
--- a/GUI/coregui/Models/SampleValidator.h
+++ b/GUI/coregui/Models/SampleValidator.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/SampleValidator.h
-//! @brief     Declares class SampleValidator
+//! @brief     Defines class SampleValidator
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Models/ScientificDoubleProperty.h b/GUI/coregui/Models/ScientificDoubleProperty.h
index 2660ae884e7ce20b44be93f3ab0d206875eec2dc..c0a82249ceba0d4c177ee68a05a7e49cf3d7d847 100644
--- a/GUI/coregui/Models/ScientificDoubleProperty.h
+++ b/GUI/coregui/Models/ScientificDoubleProperty.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/ScientificDoubleProperty.h
-//! @brief     Declares class ScientificDoubleProperty
+//! @brief     Defines class ScientificDoubleProperty
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Models/SessionGraphicsItem.h b/GUI/coregui/Models/SessionGraphicsItem.h
index ae1c54dd660e567f3e3d2bbe0e7f0c2e1bb6ecc2..845b37a96d03995fd1517a03ab86478c9551ba94 100644
--- a/GUI/coregui/Models/SessionGraphicsItem.h
+++ b/GUI/coregui/Models/SessionGraphicsItem.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/SessionGraphicsItem.h
-//! @brief     Declares class SessionGraphicsItem
+//! @brief     Defines class SessionGraphicsItem
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef SESSIONGRAPHICSITEM_H
 #define SESSIONGRAPHICSITEM_H
 
-#include "SessionItem.h" // inheriting from
+#include "SessionItem.h"
 
 class BA_CORE_API_ SessionGraphicsItem : public SessionItem
 {
diff --git a/GUI/coregui/Models/SessionItem.h b/GUI/coregui/Models/SessionItem.h
index 57043011855cf506e1a684cf6905e7e6b7c2652b..524983fc7d5c23c2a1764a7682a2fca29942ac99 100644
--- a/GUI/coregui/Models/SessionItem.h
+++ b/GUI/coregui/Models/SessionItem.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/SessionItem.h
-//! @brief     Declares class SessionItem
+//! @brief     Defines class SessionItem
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Models/SessionModel.h b/GUI/coregui/Models/SessionModel.h
index f405cf499b0ed2a0672e42218752cdaaf388704f..9bda142576c3e233dda2f1ad647e9717dd466b66 100644
--- a/GUI/coregui/Models/SessionModel.h
+++ b/GUI/coregui/Models/SessionModel.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/SessionModel.h
-//! @brief     Declares class SessionModel
+//! @brief     Defines class SessionModel
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Models/SessionModelAssistant.h b/GUI/coregui/Models/SessionModelAssistant.h
index c548fcbe75a61da060a93491d00c5cc0e2c8160b..babf8e4732aa870761980fb017c0c53ce7a3295d 100644
--- a/GUI/coregui/Models/SessionModelAssistant.h
+++ b/GUI/coregui/Models/SessionModelAssistant.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/SessionModelAssistant.h
-//! @brief     Declares class SessionModelAssistant
+//! @brief     Defines class SessionModelAssistant
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Models/SessionModelDelegate.h b/GUI/coregui/Models/SessionModelDelegate.h
index 8bb9bb5d686d3282477fb25f393e7833858a6a81..26c54e5181b6221f06589ecd6edc7bdf7f4255ee 100644
--- a/GUI/coregui/Models/SessionModelDelegate.h
+++ b/GUI/coregui/Models/SessionModelDelegate.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/SessionModelDelegate.h
-//! @brief     Declares class SessionModelDelegate
+//! @brief     Defines class SessionModelDelegate
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Models/SessionXML.h b/GUI/coregui/Models/SessionXML.h
index 2fdcb4bd329df1c47ee40ef2c303afe9368638c5..932bbf282a7daf41e3163fca42dc0e74c530d93a 100644
--- a/GUI/coregui/Models/SessionXML.h
+++ b/GUI/coregui/Models/SessionXML.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/SessionXML.h
-//! @brief     Declares reader and writer classes for SessionModel
+//! @brief     Defines reader and writer classes for SessionModel
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Models/SimulationOptionsItem.h b/GUI/coregui/Models/SimulationOptionsItem.h
index 79f8767ff3b7cbff86505762343d8fb969cedfb5..6f7d218f26bb01a4d9e9c87b8b955960aa8e1e13 100644
--- a/GUI/coregui/Models/SimulationOptionsItem.h
+++ b/GUI/coregui/Models/SimulationOptionsItem.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/SimulationOptionsItem.h
-//! @brief     Declares class SimulationOptionsItem
+//! @brief     Defines class SimulationOptionsItem
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef SIMULATIONOPTIONSITEM_H
 #define SIMULATIONOPTIONSITEM_H
 
-#include "SessionItem.h" // inheriting from
+#include "SessionItem.h"
 
 //! The SimulationOptionsItem class holds simulation status (run policy, number of threads,
 //! integration flag). Used in SimulationView to define job settings. When job is started,
diff --git a/GUI/coregui/Models/SphericalDetectorItem.h b/GUI/coregui/Models/SphericalDetectorItem.h
index d5ef5beedaae5d76526c0ba28739cd3fd2e4f797..6e0fc93150daf14c99cefeacc12d84f67ba20844 100644
--- a/GUI/coregui/Models/SphericalDetectorItem.h
+++ b/GUI/coregui/Models/SphericalDetectorItem.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/SphericalDetectorItem.h
-//! @brief     Declares class SphericalDetectorItem
+//! @brief     Defines class SphericalDetectorItem
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef SPHERICALDETECTORITEM_H
 #define SPHERICALDETECTORITEM_H
 
-#include "SessionItem.h" // inheriting from
+#include "SessionItem.h"
 
 class IDetector2D;
 class IResolutionFunction2D;
diff --git a/GUI/coregui/Models/TestItem.h b/GUI/coregui/Models/TestItem.h
index cd05c0d353b9e42a1685906702dcc947b205bb15..8889d4fc22aa4a72d5561d45e5805122ef3f2004 100644
--- a/GUI/coregui/Models/TestItem.h
+++ b/GUI/coregui/Models/TestItem.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/TestItem.h
-//! @brief     Declares class TestItem
+//! @brief     Defines class TestItem
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef TESTITEM_H
 #define TESTITEM_H
 
-#include "SessionItem.h" // inheriting from
+#include "SessionItem.h"
 
 //! The TestItem class for TestSessionItem unit tests and for checking AwesomePropertyEditor machinery
 class BA_CORE_API_ TestItem : public SessionItem
diff --git a/GUI/coregui/Models/TransformFromDomain.cpp b/GUI/coregui/Models/TransformFromDomain.cpp
index 24a0d576bb21798a67df8dcaf389591b14a65eab..79ac92c6e9971df53a3def1c19b340708cf52dd1 100644
--- a/GUI/coregui/Models/TransformFromDomain.cpp
+++ b/GUI/coregui/Models/TransformFromDomain.cpp
@@ -192,12 +192,12 @@ bool TransformFromDomain::isValidRoughness(const LayerRoughness *roughness)
 
 bool TransformFromDomain::isSquareLattice(double length1, double length2, double angle)
 {
-    return length1 == length2 && Numeric::areAlmostEqual(angle, Units::PI / 2.0);
+    return length1 == length2 && Numeric::areAlmostEqual(angle, Pi::PI / 2.0);
 }
 
 bool TransformFromDomain::isHexagonalLattice(double length1, double length2, double angle)
 {
-    return length1 == length2 && Numeric::areAlmostEqual(angle, 2*Units::PI / 3.0);
+    return length1 == length2 && Numeric::areAlmostEqual(angle, 2*Pi::PI / 3.0);
 }
 
 void TransformFromDomain::setItemFromSample(BeamItem *beamItem, const GISASSimulation &simulation)
diff --git a/GUI/coregui/Models/TransformFromDomain.h b/GUI/coregui/Models/TransformFromDomain.h
index 1458fcf3a65d75b81979a7ddaee485a1732f59a4..058bc2c1b277104076d9b268d5e3ad44b91be46b 100644
--- a/GUI/coregui/Models/TransformFromDomain.h
+++ b/GUI/coregui/Models/TransformFromDomain.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/TransformFromDomain.h
-//! @brief     Declares namespace TransformFromDomain
+//! @brief     Defines namespace TransformFromDomain
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Models/TransformToDomain.cpp b/GUI/coregui/Models/TransformToDomain.cpp
index 76b2c5471239ec0816626b0a6fabd6d3e63e847e..0b27256ef3072fc32fa9b58a7034719376f7e16e 100644
--- a/GUI/coregui/Models/TransformToDomain.cpp
+++ b/GUI/coregui/Models/TransformToDomain.cpp
@@ -197,12 +197,12 @@ TransformToDomain::createInterferenceFunction(const SessionItem& item)
             length_1 = latticeItem->getItemValue(SquareLatticeTypeItem::P_LATTICE_LENGTH)
                            .toDouble();
             length_2 = length_1;
-            alpha_lattice = Units::PI / 2.0;
+            alpha_lattice = Pi::PI / 2.0;
         } else if (latticeItem->modelType() == Constants::HexagonalLatticeType) {
             length_1 = latticeItem->getItemValue(
                                         HexagonalLatticeTypeItem::P_LATTICE_LENGTH).toDouble();
             length_2 = length_1;
-            alpha_lattice = 2 * Units::PI / 3.0;
+            alpha_lattice = 2 * Pi::PI / 3.0;
         } else {
             throw GUIHelpers::Error("TransformToDomain::createInterferenceFunction() -> Error");
         }
@@ -268,12 +268,12 @@ TransformToDomain::createInterferenceFunction(const SessionItem& item)
             length_1 = latticeItem->getItemValue(SquareLatticeTypeItem::P_LATTICE_LENGTH)
                            .toDouble();
             length_2 = length_1;
-            angle = Units::PI / 2.0;
+            angle = Pi::PI / 2.0;
         } else if (latticeItem->modelType() == Constants::HexagonalLatticeType) {
             length_1 = latticeItem->getItemValue(
                                         HexagonalLatticeTypeItem::P_LATTICE_LENGTH).toDouble();
             length_2 = length_1;
-            angle = 2 * Units::PI / 3.0;
+            angle = 2 * Pi::PI / 3.0;
         } else {
             throw GUIHelpers::Error("TransformToDomain::createInterferenceFunction() -> Error");
         }
diff --git a/GUI/coregui/Models/TransformToDomain.h b/GUI/coregui/Models/TransformToDomain.h
index 1b3b6993c4958a970abbb564864dd28a956683b1..7cc305be24f71e635d0415ad3cc4ce3c9e4c4463 100644
--- a/GUI/coregui/Models/TransformToDomain.h
+++ b/GUI/coregui/Models/TransformToDomain.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/TransformToDomain.h
-//! @brief     Declares class TransformToDomain
+//! @brief     Defines class TransformToDomain
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Models/TransformationItem.h b/GUI/coregui/Models/TransformationItem.h
index 8f31ff1e4ab9d1cf5ecc21b0c9391ea3b9677d06..4fae9265cc1b7d3681c5737b2fc5dec6c247e80a 100644
--- a/GUI/coregui/Models/TransformationItem.h
+++ b/GUI/coregui/Models/TransformationItem.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/TransformationItem.h
-//! @brief     Declares class TransformationItem
+//! @brief     Defines class TransformationItem
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef TRANSFORMATIONITEM_H
 #define TRANSFORMATIONITEM_H
 
-#include "SessionGraphicsItem.h" // inheriting from
+#include "SessionGraphicsItem.h"
 
 class TransformationItem : public SessionGraphicsItem
 {
diff --git a/GUI/coregui/Models/VectorItem.h b/GUI/coregui/Models/VectorItem.h
index 33e6b18183db8a34cdfccb9c8d86549525a1ddf9..ea173b562eb36710df8d851e94a3feab14cf7fe4 100644
--- a/GUI/coregui/Models/VectorItem.h
+++ b/GUI/coregui/Models/VectorItem.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/VectorItem.h
-//! @brief     Declares class VectorItem
+//! @brief     Defines class VectorItem
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef VECTORITEM_H
 #define VECTORITEM_H
 
-#include "SessionItem.h" // inheriting from
+#include "SessionItem.h"
 #include "Vectors3D.h"
 
 class BA_CORE_API_  VectorItem : public SessionItem
diff --git a/GUI/coregui/Models/item_constants.h b/GUI/coregui/Models/item_constants.h
index 78ca3bfec852fab6e268dcb3cd0fee226f28fd28..76c19c2c187098835c3d8e95822dd3520e06bcec 100644
--- a/GUI/coregui/Models/item_constants.h
+++ b/GUI/coregui/Models/item_constants.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Models/item_constants.h
-//! @brief     Declares item constants
+//! @brief     Defines item constants
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/AccordionWidget/AccordionWidget.h b/GUI/coregui/Views/AccordionWidget/AccordionWidget.h
index 8a511491daf5d9d811a65c8e84882f34fb45d063..7ee4e93f8e67264e52c5d333f6cdc2904afddeec 100644
--- a/GUI/coregui/Views/AccordionWidget/AccordionWidget.h
+++ b/GUI/coregui/Views/AccordionWidget/AccordionWidget.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/AccordionWidget/AccordionWidget.h
-//! @brief     Declares AccordionWidget class
+//! @brief     Defines AccordionWidget class
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/AccordionWidget/ClickableFrame.h b/GUI/coregui/Views/AccordionWidget/ClickableFrame.h
index fe93270795d18f0bd0a9c2d0e147a8744ab998d9..132b5eb94c08ef0247acc719080e68f4c1e0f79c 100644
--- a/GUI/coregui/Views/AccordionWidget/ClickableFrame.h
+++ b/GUI/coregui/Views/AccordionWidget/ClickableFrame.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/AccordionWidget/ClickableFrame.h
-//! @brief     Declares AccordionWidget class
+//! @brief     Defines AccordionWidget class
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/AccordionWidget/ContentPane.h b/GUI/coregui/Views/AccordionWidget/ContentPane.h
index faad4ea5d7f54b830595499809b89840ed21bee2..b64ec65913c38c5b3a9ccf55b114d8800d152a1b 100644
--- a/GUI/coregui/Views/AccordionWidget/ContentPane.h
+++ b/GUI/coregui/Views/AccordionWidget/ContentPane.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/AccordionWidget/ContentPane.h
-//! @brief     Declares ContentPane class
+//! @brief     Defines ContentPane class
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/CommonWidgets/InfoPanel.h b/GUI/coregui/Views/CommonWidgets/InfoPanel.h
index b4f52ac104daf05d14e7f2004c14494fe98ce5cb..cbdd1314017756bdbba5b8959fad511b614f8c6d 100644
--- a/GUI/coregui/Views/CommonWidgets/InfoPanel.h
+++ b/GUI/coregui/Views/CommonWidgets/InfoPanel.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/CommonWidgets/InfoPanel.h
-//! @brief     Declares class InfoPanel
+//! @brief     Defines class InfoPanel
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/CommonWidgets/InfoPanelToolBar.h b/GUI/coregui/Views/CommonWidgets/InfoPanelToolBar.h
index ecb0d1882c7fe42b4e22938bec2760b75bb7402d..8849442bcac552bb73480977f58007567f479ecc 100644
--- a/GUI/coregui/Views/CommonWidgets/InfoPanelToolBar.h
+++ b/GUI/coregui/Views/CommonWidgets/InfoPanelToolBar.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/CommonWidgets/InfoPanelToolBar.h
-//! @brief     Declares class InfoPanelToolBar
+//! @brief     Defines class InfoPanelToolBar
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef INFOPANELTOOLBAR_H
 #define INFOPANELTOOLBAR_H
 
-#include "StyledToolBar.h" // inheriting from
+#include "StyledToolBar.h"
 
 class QToolButton;
 
diff --git a/GUI/coregui/Views/CommonWidgets/ItemComboToolBar.h b/GUI/coregui/Views/CommonWidgets/ItemComboToolBar.h
index dae67de2681cc7d933bc44bc9cee26963257ba8a..bd463e7253095c619b3e46077690e27a1c52ca26 100644
--- a/GUI/coregui/Views/CommonWidgets/ItemComboToolBar.h
+++ b/GUI/coregui/Views/CommonWidgets/ItemComboToolBar.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/CommonWidgets/ItemComboToolBar.h
-//! @brief     Declares class ItemComboToolBar
+//! @brief     Defines class ItemComboToolBar
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef ITEMCOMBOTOOLBAR_H
 #define ITEMCOMBOTOOLBAR_H
 
-#include "StyledToolBar.h" // inheriting from
+#include "StyledToolBar.h"
 #include <QList>
 
 class QAction;
diff --git a/GUI/coregui/Views/CommonWidgets/ItemComboWidget.h b/GUI/coregui/Views/CommonWidgets/ItemComboWidget.h
index 9d9ecc72674915323a2b22aeadae323928c0bb0f..e0ade16b4f765907ecd1356ef13fa7c2a206770a 100644
--- a/GUI/coregui/Views/CommonWidgets/ItemComboWidget.h
+++ b/GUI/coregui/Views/CommonWidgets/ItemComboWidget.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/CommonWidgets/ItemComboWidget.h
-//! @brief     Declares class ItemComboWidget
+//! @brief     Defines class ItemComboWidget
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/CommonWidgets/ItemSelectorWidget.h b/GUI/coregui/Views/CommonWidgets/ItemSelectorWidget.h
index 61243d24a592106cb4cd92d02d22c18567cad6f8..ae074e84f8ac3978fbfec19f09f78f53ce00dc5e 100644
--- a/GUI/coregui/Views/CommonWidgets/ItemSelectorWidget.h
+++ b/GUI/coregui/Views/CommonWidgets/ItemSelectorWidget.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/CommonWidgets/ItemSelectorWidget.h
-//! @brief     Declares class ItemSelectorWidget
+//! @brief     Defines class ItemSelectorWidget
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/CommonWidgets/ItemStackPresenter.h b/GUI/coregui/Views/CommonWidgets/ItemStackPresenter.h
index 8890dce683f2fcaa65ed8d92f0f3271672023f9d..bfab617b8fff1cf4debf8dea75494a9c75a41ce5 100644
--- a/GUI/coregui/Views/CommonWidgets/ItemStackPresenter.h
+++ b/GUI/coregui/Views/CommonWidgets/ItemStackPresenter.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/CommonWidgets/ItemStackPresenter.h
-//! @brief     Declares class ItemStackPresenter
+//! @brief     Defines class ItemStackPresenter
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef ITEMSTACKPRESENTER_H
 #define ITEMSTACKPRESENTER_H
 
-#include "ItemStackWidget.h" // inheriting from
+#include "ItemStackWidget.h"
 #include <QDebug>
 #include <QMap>
 #include <QStackedWidget>
diff --git a/GUI/coregui/Views/CommonWidgets/ItemStackWidget.h b/GUI/coregui/Views/CommonWidgets/ItemStackWidget.h
index f7679972c11acbb8903086a276063cad5ce2f156..fe6ed0a0fe6515af520045d00eddffc0a4edb885 100644
--- a/GUI/coregui/Views/CommonWidgets/ItemStackWidget.h
+++ b/GUI/coregui/Views/CommonWidgets/ItemStackWidget.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/CommonWidgets/ItemStackWidget.h
-//! @brief     Declares class ItemStackWidget
+//! @brief     Defines class ItemStackWidget
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/CommonWidgets/SessionItemWidget.h b/GUI/coregui/Views/CommonWidgets/SessionItemWidget.h
index 2f149f330e63fd85081f549b83f8b6fbf031006c..809f48d4ee917784a26179f55249c7918327e07d 100644
--- a/GUI/coregui/Views/CommonWidgets/SessionItemWidget.h
+++ b/GUI/coregui/Views/CommonWidgets/SessionItemWidget.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/CommonWidgets/SessionItemWidget.h
-//! @brief     Declares class ItemComboWidget
+//! @brief     Defines class ItemComboWidget
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/CommonWidgets/StatusLabel.h b/GUI/coregui/Views/CommonWidgets/StatusLabel.h
index 2b25a1ef8918d568adf7d929eaac87760f43dbd8..dd2ef0d9999b53bbd0520e49ca80b446dcadfaa7 100644
--- a/GUI/coregui/Views/CommonWidgets/StatusLabel.h
+++ b/GUI/coregui/Views/CommonWidgets/StatusLabel.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/CommonWidgets/StatusLabel.h
-//! @brief     Declares class StatusLabel
+//! @brief     Defines class StatusLabel
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/CommonWidgets/UpdateTimer.h b/GUI/coregui/Views/CommonWidgets/UpdateTimer.h
index f889f8154bb4534643ce16626d24d4ef7372ca91..8cf95bcf583d94c905f0fa1592c4669a70b06dd5 100644
--- a/GUI/coregui/Views/CommonWidgets/UpdateTimer.h
+++ b/GUI/coregui/Views/CommonWidgets/UpdateTimer.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/CommonWidgets/UpdateTimer.h
-//! @brief     Declares class UpdateTimer
+//! @brief     Defines class UpdateTimer
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/FitWidgets/FitActivityPanel.h b/GUI/coregui/Views/FitWidgets/FitActivityPanel.h
index 172bcbc1008adc963c54548f951b18ecf18a7f42..5eb584785180704d1ab89530289ca68723207b51 100644
--- a/GUI/coregui/Views/FitWidgets/FitActivityPanel.h
+++ b/GUI/coregui/Views/FitWidgets/FitActivityPanel.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/FitWidgets/FitActivityPanel.h
-//! @brief     Declares class FitActivityPanel
+//! @brief     Defines class FitActivityPanel
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/FitWidgets/FitComparisonWidget.h b/GUI/coregui/Views/FitWidgets/FitComparisonWidget.h
index fcc5d8e6a2bd13b712b41fa33c03d5e64f7ee3be..4824988a28351176b6fbd771905d598a31bdedf0 100644
--- a/GUI/coregui/Views/FitWidgets/FitComparisonWidget.h
+++ b/GUI/coregui/Views/FitWidgets/FitComparisonWidget.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/FitWidgets/FitComparisonWidget.h
-//! @brief     Declares class FitComparisonWidget
+//! @brief     Defines class FitComparisonWidget
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef FITCOMPARISONWIDGET_H
 #define FITCOMPARISONWIDGET_H
 
-#include "SessionItemWidget.h" // inheriting from
+#include "SessionItemWidget.h"
 #include <QMap>
 
 class JobItem;
diff --git a/GUI/coregui/Views/FitWidgets/FitFlowWidget.h b/GUI/coregui/Views/FitWidgets/FitFlowWidget.h
index 14b5f21ffacf5d4f8c49bde603d20aec4f1e4ac4..3c616b28fa4f989a4cac69c521176ee5e39d3164 100644
--- a/GUI/coregui/Views/FitWidgets/FitFlowWidget.h
+++ b/GUI/coregui/Views/FitWidgets/FitFlowWidget.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/FitWidgets/FitFlowWidget.h
-//! @brief     Declares class FitFlowWidget
+//! @brief     Defines class FitFlowWidget
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/FitWidgets/FitParameterWidget.h b/GUI/coregui/Views/FitWidgets/FitParameterWidget.h
index a3a2aa46e7070a51cb6f91ace2e337829964b096..f3078a750de1480f0cd0a5e51d6b6da291771572 100644
--- a/GUI/coregui/Views/FitWidgets/FitParameterWidget.h
+++ b/GUI/coregui/Views/FitWidgets/FitParameterWidget.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/FitWidgets/FitParameterWidget.h
-//! @brief     Declares class FitParameterWidget
+//! @brief     Defines class FitParameterWidget
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/FitWidgets/FitProgressInfo.h b/GUI/coregui/Views/FitWidgets/FitProgressInfo.h
index fe6f726cd5a3db0090220fb200a97fb76c0eb6c7..388e0ff2259cb5f9b24b58bdba2f249d88e39822 100644
--- a/GUI/coregui/Views/FitWidgets/FitProgressInfo.h
+++ b/GUI/coregui/Views/FitWidgets/FitProgressInfo.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/FitWidgets/FitProgressInfo.h
-//! @brief     Declares class FitProgressInfo
+//! @brief     Defines class FitProgressInfo
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/FitWidgets/FitResultsWidget.h b/GUI/coregui/Views/FitWidgets/FitResultsWidget.h
index 34fb532def7d1d5922948870ba136597cd64959f..233c9fb4a09f3d0ae5b8d6393ef72637b9bbfd40 100644
--- a/GUI/coregui/Views/FitWidgets/FitResultsWidget.h
+++ b/GUI/coregui/Views/FitWidgets/FitResultsWidget.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/FitWidgets/FitResultsWidget.h
-//! @brief     Declares class FitResultsWidget
+//! @brief     Defines class FitResultsWidget
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/FitWidgets/FitSuiteWidget.h b/GUI/coregui/Views/FitWidgets/FitSuiteWidget.h
index eeb1d28ee214b23327a4923ffa3c4351423d2434..817861482fc899803d74c7368ae9e61a7dc604fc 100644
--- a/GUI/coregui/Views/FitWidgets/FitSuiteWidget.h
+++ b/GUI/coregui/Views/FitWidgets/FitSuiteWidget.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/FitWidgets/FitSuiteWidget.h
-//! @brief     Declares class FitSuiteWidget
+//! @brief     Defines class FitSuiteWidget
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/FitWidgets/HistogramPlot.h b/GUI/coregui/Views/FitWidgets/HistogramPlot.h
index 5c959d39f9f986bd3684ab2460e87a92139e7cc1..8ee932a6112da908c2f1db37b8cdb49949b14407 100644
--- a/GUI/coregui/Views/FitWidgets/HistogramPlot.h
+++ b/GUI/coregui/Views/FitWidgets/HistogramPlot.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/FitWidgets/HistogramPlot.h
-//! @brief     Declares class HistogramPlot
+//! @brief     Defines class HistogramPlot
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/FitWidgets/MinimizerSettingsWidget.h b/GUI/coregui/Views/FitWidgets/MinimizerSettingsWidget.h
index a17b81fa72f1f783a3aacb2fe1446ed297138916..5dd939ad86783133b84b8545f903eab7dbd5d84f 100644
--- a/GUI/coregui/Views/FitWidgets/MinimizerSettingsWidget.h
+++ b/GUI/coregui/Views/FitWidgets/MinimizerSettingsWidget.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/FitWidgets/MinimizerSettingsWidget.h
-//! @brief     Declares class MinimizerSettingsWidget
+//! @brief     Defines class MinimizerSettingsWidget
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/FitWidgets/RunFitControlWidget.h b/GUI/coregui/Views/FitWidgets/RunFitControlWidget.h
index 6b9a8190c057cb4efc73da229d44b1652b2b12ea..9fdbb276635dd77551b14c6cbb30aa8567a19ced 100644
--- a/GUI/coregui/Views/FitWidgets/RunFitControlWidget.h
+++ b/GUI/coregui/Views/FitWidgets/RunFitControlWidget.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/FitWidgets/RunFitControlWidget.h
-//! @brief     Declares class RunFitControlWidget
+//! @brief     Defines class RunFitControlWidget
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/FitWidgets/TestFitWidgets.h b/GUI/coregui/Views/FitWidgets/TestFitWidgets.h
index 0513e9a13bd37162685401f357295603b25c99b8..3ee18ecdf472eae32ab97f0d5fe9907708cfe040 100644
--- a/GUI/coregui/Views/FitWidgets/TestFitWidgets.h
+++ b/GUI/coregui/Views/FitWidgets/TestFitWidgets.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/FitWidgets/TestFitWidgets.h
-//! @brief     Declares class TestFitWidgets
+//! @brief     Defines class TestFitWidgets
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/FitWidgets/plot_constants.h b/GUI/coregui/Views/FitWidgets/plot_constants.h
index 9c8123aa76f55dbc068c5a85d494fefd2b2c90f0..afe4673576901e6386a842b73205cbc980d1b221 100644
--- a/GUI/coregui/Views/FitWidgets/plot_constants.h
+++ b/GUI/coregui/Views/FitWidgets/plot_constants.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/FitWidgets/plot_constants.h
-//! @brief     Declares various constants for plotting
+//! @brief     Defines various constants for plotting
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/ImportDataView.h b/GUI/coregui/Views/ImportDataView.h
index d3d8b9be41e72f0abbb73b89de701d557fb5d381..98af3a6e80acfd5356c28f8a7c51830eacccf1a0 100644
--- a/GUI/coregui/Views/ImportDataView.h
+++ b/GUI/coregui/Views/ImportDataView.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/ImportDataView.h
-//! @brief     Declares class ImportDataView
+//! @brief     Defines class ImportDataView
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/ImportDataWidgets/ImportDataAssistant.h b/GUI/coregui/Views/ImportDataWidgets/ImportDataAssistant.h
index 3d3bfee16e27a7ee73dcf6a1e96d5703c36c4120..b634a6740c77ca80296ecc9fa803a62ca4bac581 100644
--- a/GUI/coregui/Views/ImportDataWidgets/ImportDataAssistant.h
+++ b/GUI/coregui/Views/ImportDataWidgets/ImportDataAssistant.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/ImportDataWidgets/ImportDataAssistant.h
-//! @brief     Declares class ImportDataAssistant
+//! @brief     Defines class ImportDataAssistant
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/ImportDataWidgets/ImportDataToolBar.h b/GUI/coregui/Views/ImportDataWidgets/ImportDataToolBar.h
index f65717ce5edcb85ab6ccbcbf5b5736880e13317b..6997548ab97c3de020209ad20bffa7d1ab6094fd 100644
--- a/GUI/coregui/Views/ImportDataWidgets/ImportDataToolBar.h
+++ b/GUI/coregui/Views/ImportDataWidgets/ImportDataToolBar.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/ImportDataWidgets/ImportDataToolBar.h
-//! @brief     Declares class ImportDataToolBar
+//! @brief     Defines class ImportDataToolBar
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef IMPORTDATATOOLBAR_H
 #define IMPORTDATATOOLBAR_H
 
-#include "StyledToolBar.h" // inheriting from
+#include "StyledToolBar.h"
 
 class QAction;
 class RealDataModel;
diff --git a/GUI/coregui/Views/ImportDataWidgets/RealDataEditorWidget.h b/GUI/coregui/Views/ImportDataWidgets/RealDataEditorWidget.h
index 249dc18e2a6141092e78495bdeddedcfc4463c2a..c3984c01d3e07efd1013bccafa12f5a5d0e4cbd9 100644
--- a/GUI/coregui/Views/ImportDataWidgets/RealDataEditorWidget.h
+++ b/GUI/coregui/Views/ImportDataWidgets/RealDataEditorWidget.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/ImportDataWidgets/RealDataEditorWidget.h
-//! @brief     Declares class RealDataEditorWidget
+//! @brief     Defines class RealDataEditorWidget
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef REALDATAEDITORWIDGET_H
 #define REALDATAEDITORWIDGET_H
 
-#include "SessionItemWidget.h" // inheriting from
+#include "SessionItemWidget.h"
 
 class SessionItem;
 class IntensityDataWidget;
diff --git a/GUI/coregui/Views/ImportDataWidgets/RealDataSelectorWidget.h b/GUI/coregui/Views/ImportDataWidgets/RealDataSelectorWidget.h
index 81dcceaf1514eb920c3cc2368b96d05b87ec5469..62f967c48aec2a436e237b5414f6bd1eadbabdf1 100644
--- a/GUI/coregui/Views/ImportDataWidgets/RealDataSelectorWidget.h
+++ b/GUI/coregui/Views/ImportDataWidgets/RealDataSelectorWidget.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/ImportDataWidgets/RealDataSelectorWidget.h
-//! @brief     Declares class RealDataSelectorWidget
+//! @brief     Defines class RealDataSelectorWidget
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/InfoWidgets/DistributionDialog.h b/GUI/coregui/Views/InfoWidgets/DistributionDialog.h
index b4cf54623daaffbbaec317ea537bb5c8c88e73a2..6534d8e9261b9b8f6b9e014334f348c512eb6bca 100644
--- a/GUI/coregui/Views/InfoWidgets/DistributionDialog.h
+++ b/GUI/coregui/Views/InfoWidgets/DistributionDialog.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/InfoWidgets/DistributionDialog.h
-//! @brief     Declares class DistributionDialog
+//! @brief     Defines class DistributionDialog
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/InfoWidgets/DistributionEditor.h b/GUI/coregui/Views/InfoWidgets/DistributionEditor.h
index 6dc73b58dd08bd95193b72c65a91a7df12ed36bb..097c9c51e764dc660dc4b0ee04362e4ee57dc357 100644
--- a/GUI/coregui/Views/InfoWidgets/DistributionEditor.h
+++ b/GUI/coregui/Views/InfoWidgets/DistributionEditor.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/InfoWidgets/DistributionEditor.h
-//! @brief     Declares class DistributionEditor
+//! @brief     Defines class DistributionEditor
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/InfoWidgets/DistributionWidget.h b/GUI/coregui/Views/InfoWidgets/DistributionWidget.h
index a0a7520fa1361da6e1d6133c781dcc473bc2260c..e4551d370351741d0e56c6818a469d54cf62cc3f 100644
--- a/GUI/coregui/Views/InfoWidgets/DistributionWidget.h
+++ b/GUI/coregui/Views/InfoWidgets/DistributionWidget.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/InfoWidgets/DistributionWidget.h
-//! @brief     Declares class DistributionWidget
+//! @brief     Defines class DistributionWidget
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/InfoWidgets/GroupInfoBox.h b/GUI/coregui/Views/InfoWidgets/GroupInfoBox.h
index 57462681e6798b592c8b7f3375e28501821e85dd..867799090b46d54887782587415e87d0ea06c04c 100644
--- a/GUI/coregui/Views/InfoWidgets/GroupInfoBox.h
+++ b/GUI/coregui/Views/InfoWidgets/GroupInfoBox.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/InfoWidgets/GroupInfoBox.h
-//! @brief     Declares class GroupInfoBox
+//! @brief     Defines class GroupInfoBox
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/InfoWidgets/InfoToolBar.h b/GUI/coregui/Views/InfoWidgets/InfoToolBar.h
index 26e834333e17f738bc16a1ac51de27d5c77acbe7..96eca7aaa4edbf21e558596c550af74d87bcd953 100644
--- a/GUI/coregui/Views/InfoWidgets/InfoToolBar.h
+++ b/GUI/coregui/Views/InfoWidgets/InfoToolBar.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/InfoWidgets/InfoToolBar.h
-//! @brief     Declares class InfoToolBar
+//! @brief     Defines class InfoToolBar
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef INFOTOOLBAR_H
 #define INFOTOOLBAR_H
 
-#include "StyledToolBar.h" // inheriting from
+#include "StyledToolBar.h"
 
 class QToolButton;
 
diff --git a/GUI/coregui/Views/InfoWidgets/InfoWidget.h b/GUI/coregui/Views/InfoWidgets/InfoWidget.h
index 0d73dba66ce27a46752ac0570f0a2f96e46a3f23..0350b99af9c3ea475318f999243d1febd81830c8 100644
--- a/GUI/coregui/Views/InfoWidgets/InfoWidget.h
+++ b/GUI/coregui/Views/InfoWidgets/InfoWidget.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/InfoWidgets/InfoWidget.h
-//! @brief     Declares class InfoWidget
+//! @brief     Defines class InfoWidget
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/InfoWidgets/OverlayLabelController.h b/GUI/coregui/Views/InfoWidgets/OverlayLabelController.h
index b0a4f9008e9b55a10c564f1221aeca440e74d4d8..1aff76c39998f91d1fdf4ae40bbac2a99b54e448 100644
--- a/GUI/coregui/Views/InfoWidgets/OverlayLabelController.h
+++ b/GUI/coregui/Views/InfoWidgets/OverlayLabelController.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/InfoWidgets/OverlayLabelController.h
-//! @brief     Declares class OverlayLabelController
+//! @brief     Defines class OverlayLabelController
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/InfoWidgets/OverlayLabelWidget.h b/GUI/coregui/Views/InfoWidgets/OverlayLabelWidget.h
index 0ecc7858456450c15d70c299a591473d2089addd..01c50a0d1c17b15690c091f57e3365732ecadc8a 100644
--- a/GUI/coregui/Views/InfoWidgets/OverlayLabelWidget.h
+++ b/GUI/coregui/Views/InfoWidgets/OverlayLabelWidget.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/InfoWidgets/OverlayLabelWidget.h
-//! @brief     Declares class OverlayLabelWidget
+//! @brief     Defines class OverlayLabelWidget
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/InfoWidgets/ProjectLoadWarningDialog.h b/GUI/coregui/Views/InfoWidgets/ProjectLoadWarningDialog.h
index 0fd0996122034d41d38ea402b0429c56445113b4..4da9469a9f75341a4557fa2443528e2ac020c442 100644
--- a/GUI/coregui/Views/InfoWidgets/ProjectLoadWarningDialog.h
+++ b/GUI/coregui/Views/InfoWidgets/ProjectLoadWarningDialog.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/InfoWidgets/ProjectLoadWarningDialog.h
-//! @brief     Declares class ProjectLoadWarningDialog
+//! @brief     Defines class ProjectLoadWarningDialog
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/InfoWidgets/PySampleWidget.h b/GUI/coregui/Views/InfoWidgets/PySampleWidget.h
index 5c7b0c51c768e54d1513c0f21d777e6c3de75ff1..093b7377b244b3add5f608c3309697a3ae73cdf2 100644
--- a/GUI/coregui/Views/InfoWidgets/PySampleWidget.h
+++ b/GUI/coregui/Views/InfoWidgets/PySampleWidget.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/InfoWidgets/PySampleWidget.h
-//! @brief     Declares class PySampleWidget
+//! @brief     Defines class PySampleWidget
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/InfoWidgets/PythonSyntaxHighlighter.h b/GUI/coregui/Views/InfoWidgets/PythonSyntaxHighlighter.h
index e3033e70f89919ad8c77eaa26585bd2960d53020..24a708a384dae741fdfd42fd3f1caba546353225 100644
--- a/GUI/coregui/Views/InfoWidgets/PythonSyntaxHighlighter.h
+++ b/GUI/coregui/Views/InfoWidgets/PythonSyntaxHighlighter.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/InfoWidgets/PythonSyntaxHighlighter.h
-//! @brief     Declares class PythonSyntaxHighlighter
+//! @brief     Defines class PythonSyntaxHighlighter
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/InfoWidgets/WarningSignWidget.h b/GUI/coregui/Views/InfoWidgets/WarningSignWidget.h
index 21c56a41ccdf6243df6bb81ac6a323c05423cd40..91eb1ecc87444c621b051e49d95af2d234e8787a 100644
--- a/GUI/coregui/Views/InfoWidgets/WarningSignWidget.h
+++ b/GUI/coregui/Views/InfoWidgets/WarningSignWidget.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/InfoWidgets/WarningSignWidget.h
-//! @brief     Declares class WarningSignWidget
+//! @brief     Defines class WarningSignWidget
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/InstrumentView.h b/GUI/coregui/Views/InstrumentView.h
index 62c582dcf7a395d253f34c7438f62f8f4456efa3..d8c5bea8869a66650c8f50885f64a8a22a992339 100644
--- a/GUI/coregui/Views/InstrumentView.h
+++ b/GUI/coregui/Views/InstrumentView.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/InstrumentView.h
-//! @brief     Declares class InstrumentView
+//! @brief     Defines class InstrumentView
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/InstrumentWidgets/BeamEditorWidget.h b/GUI/coregui/Views/InstrumentWidgets/BeamEditorWidget.h
index 6931ed609ebdab1c6bd1ca806a60290b0614f895..81d0e25f27ef0e6be2d1fa3ab50955061e4d34ba 100644
--- a/GUI/coregui/Views/InstrumentWidgets/BeamEditorWidget.h
+++ b/GUI/coregui/Views/InstrumentWidgets/BeamEditorWidget.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/InstrumentWidgets/BeamEditorWidget.h
-//! @brief     Declares class BeamEditorWidget
+//! @brief     Defines class BeamEditorWidget
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/InstrumentWidgets/ComboWidget.h b/GUI/coregui/Views/InstrumentWidgets/ComboWidget.h
index 72bed5c4db6fca71ae4f22a801ceef9e25cc8055..413542b39fabf27253624d57fd7463c3fe3b29bf 100644
--- a/GUI/coregui/Views/InstrumentWidgets/ComboWidget.h
+++ b/GUI/coregui/Views/InstrumentWidgets/ComboWidget.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/InstrumentWidgets/ComboWidget.h
-//! @brief     Declares class ComboWidget
+//! @brief     Defines class ComboWidget
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/InstrumentWidgets/ComponentInfoBox.h b/GUI/coregui/Views/InstrumentWidgets/ComponentInfoBox.h
index 6236bda4a2a3441c99810e2d1b31807caf7918c2..8f0845e26a968c755425b0e3b852169d632ac8c8 100644
--- a/GUI/coregui/Views/InstrumentWidgets/ComponentInfoBox.h
+++ b/GUI/coregui/Views/InstrumentWidgets/ComponentInfoBox.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/InstrumentWidgets/ComponentInfoBox.h
-//! @brief     Declares class ComponentInfoBox
+//! @brief     Defines class ComponentInfoBox
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/InstrumentWidgets/DetectorEditorWidget.h b/GUI/coregui/Views/InstrumentWidgets/DetectorEditorWidget.h
index 929b326350a553a878635171e1fd23cf6e40d066..7a06ed59258da881dec585ef58251c6e6e0e47f4 100644
--- a/GUI/coregui/Views/InstrumentWidgets/DetectorEditorWidget.h
+++ b/GUI/coregui/Views/InstrumentWidgets/DetectorEditorWidget.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/InstrumentWidgets/DetectorEditorWidget.h
-//! @brief     Declares class DetectorEditorWidget
+//! @brief     Defines class DetectorEditorWidget
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/InstrumentWidgets/DetectorMaskDelegate.h b/GUI/coregui/Views/InstrumentWidgets/DetectorMaskDelegate.h
index 9608fdc0420d01734f706726758cc3f4bbc81fb4..4c70f6daab97bfa2cbb36f1ebaeb7cd5ad85c06f 100644
--- a/GUI/coregui/Views/InstrumentWidgets/DetectorMaskDelegate.h
+++ b/GUI/coregui/Views/InstrumentWidgets/DetectorMaskDelegate.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/InstrumentWidgets/DetectorMaskDelegate.h
-//! @brief     Declares class DetectorMaskDelegate
+//! @brief     Defines class DetectorMaskDelegate
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/InstrumentWidgets/ExtendedDetectorDialog.h b/GUI/coregui/Views/InstrumentWidgets/ExtendedDetectorDialog.h
index 439c2f90aa63cf3d8bfdff9492e79c262fcb877a..1f4f75dfd1bc1d0fcc95e16a3500b9a932ff154d 100644
--- a/GUI/coregui/Views/InstrumentWidgets/ExtendedDetectorDialog.h
+++ b/GUI/coregui/Views/InstrumentWidgets/ExtendedDetectorDialog.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/InstrumentWidgets/ExtendedDetectorDialog.h
-//! @brief     Declares class DistributionDialog
+//! @brief     Defines class DistributionDialog
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/InstrumentWidgets/InstrumentComponentsWidget.h b/GUI/coregui/Views/InstrumentWidgets/InstrumentComponentsWidget.h
index f38d985678b36427fbf8430178a412000567f5bd..a053de5ba54d421dba0544655c167bf449c22a7c 100644
--- a/GUI/coregui/Views/InstrumentWidgets/InstrumentComponentsWidget.h
+++ b/GUI/coregui/Views/InstrumentWidgets/InstrumentComponentsWidget.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/InstrumentWidgets/InstrumentComponentsWidget.h
-//! @brief     Declares class InstrumentComponentsWidget
+//! @brief     Defines class InstrumentComponentsWidget
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/InstrumentWidgets/InstrumentEditorWidget.h b/GUI/coregui/Views/InstrumentWidgets/InstrumentEditorWidget.h
index 03b238f4fa7e7bccf018810a9376318e3511767a..4f97785ee75e8d32b4ce8b2dd168de39e0c1d48d 100644
--- a/GUI/coregui/Views/InstrumentWidgets/InstrumentEditorWidget.h
+++ b/GUI/coregui/Views/InstrumentWidgets/InstrumentEditorWidget.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/InstrumentWidgets/InstrumentEditorWidget.h
-//! @brief     Declares class InstrumentEditorWidget
+//! @brief     Defines class InstrumentEditorWidget
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/InstrumentWidgets/InstrumentSelectorWidget.h b/GUI/coregui/Views/InstrumentWidgets/InstrumentSelectorWidget.h
index 3cd7f30f5742414257ba587f8cfc294b6b7d581b..8e8cee972fec1a4c89a10bbd113cf5d5d97f1b40 100644
--- a/GUI/coregui/Views/InstrumentWidgets/InstrumentSelectorWidget.h
+++ b/GUI/coregui/Views/InstrumentWidgets/InstrumentSelectorWidget.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/InstrumentWidgets/InstrumentSelectorWidget.h
-//! @brief     Declares class InstrumentSelectorWidget
+//! @brief     Defines class InstrumentSelectorWidget
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/InstrumentWidgets/RectangularDetectorWidget.h b/GUI/coregui/Views/InstrumentWidgets/RectangularDetectorWidget.h
index 742b1390962b691826b381007143b4b59cb04501..1dbc6e8765bea1c08e0cedfd7273ee0ad9356809 100644
--- a/GUI/coregui/Views/InstrumentWidgets/RectangularDetectorWidget.h
+++ b/GUI/coregui/Views/InstrumentWidgets/RectangularDetectorWidget.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/InstrumentWidgets/RectangularDetectorWidget.h
-//! @brief     Declares class RectangularDetectorWidget
+//! @brief     Defines class RectangularDetectorWidget
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/InstrumentWidgets/SphericalDetectorWidget.h b/GUI/coregui/Views/InstrumentWidgets/SphericalDetectorWidget.h
index 6e401b60915171d39b9eaec5fa64bc625f2c276c..62c0a54b17eac15e5a92afac3778c24d632d756f 100644
--- a/GUI/coregui/Views/InstrumentWidgets/SphericalDetectorWidget.h
+++ b/GUI/coregui/Views/InstrumentWidgets/SphericalDetectorWidget.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/InstrumentWidgets/SphericalDetectorWidget.h
-//! @brief     Declares class SphericalDetectorWidget
+//! @brief     Defines class SphericalDetectorWidget
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/InstrumentWidgets/columnresizer.h b/GUI/coregui/Views/InstrumentWidgets/columnresizer.h
index 002aa506ba4f6a85dd68eac35e4b8d19d3eb1617..ca1fa37013772ecbc0b329825d51d31bf80ab045 100644
--- a/GUI/coregui/Views/InstrumentWidgets/columnresizer.h
+++ b/GUI/coregui/Views/InstrumentWidgets/columnresizer.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/InstrumentWidgets/columnresizer.h
-//! @brief     Declares class ColumnResizer
+//! @brief     Defines class ColumnResizer
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/IntensityDataWidgets/ColorMap.cpp b/GUI/coregui/Views/IntensityDataWidgets/ColorMap.cpp
index ce0f249f18442bff016637851796dd3f2010ed18..9c159a250dc4aa46714c39976d5a0717139f5995 100644
--- a/GUI/coregui/Views/IntensityDataWidgets/ColorMap.cpp
+++ b/GUI/coregui/Views/IntensityDataWidgets/ColorMap.cpp
@@ -20,7 +20,7 @@
 #include "ColorMapHelper.h"
 #include "GUIHelpers.h"
 #include "IntensityDataItem.h"
-#include "Units.h"
+#include "Pi.h"
 #include "UpdateTimer.h"
 #include "plot_constants.h"
 #include <QDebug>
diff --git a/GUI/coregui/Views/IntensityDataWidgets/ColorMap.h b/GUI/coregui/Views/IntensityDataWidgets/ColorMap.h
index 6a06a0b85b02cffebf12ad596129e07d6f3d557a..42db4b968511f10a4b56ad9be9f9358374515561 100644
--- a/GUI/coregui/Views/IntensityDataWidgets/ColorMap.h
+++ b/GUI/coregui/Views/IntensityDataWidgets/ColorMap.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/IntensityDataWidgets/ColorMap.h
-//! @brief     Declares class ColorMap
+//! @brief     Defines class ColorMap
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/IntensityDataWidgets/ColorMapBin.h b/GUI/coregui/Views/IntensityDataWidgets/ColorMapBin.h
index 5b1ab2c2515c143e8b0719522022314d5bbb18de..2d7f82f6e8036bd3f61f9c505a33bb3eb5de1112 100644
--- a/GUI/coregui/Views/IntensityDataWidgets/ColorMapBin.h
+++ b/GUI/coregui/Views/IntensityDataWidgets/ColorMapBin.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/IntensityDataWidgets/ColorMapBin.h
-//! @brief     Declares class ColorMapBin
+//! @brief     Defines class ColorMapBin
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/IntensityDataWidgets/ColorMapCanvas.h b/GUI/coregui/Views/IntensityDataWidgets/ColorMapCanvas.h
index 1584480c7c7bed28a75e8dfffb9381409a02ea05..59215fbd7f99d24d8592ead7531945262d9a80b0 100644
--- a/GUI/coregui/Views/IntensityDataWidgets/ColorMapCanvas.h
+++ b/GUI/coregui/Views/IntensityDataWidgets/ColorMapCanvas.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/IntensityDataWidgets/ColorMapCanvas.h
-//! @brief     Declares class ColorMapCanvas
+//! @brief     Defines class ColorMapCanvas
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/IntensityDataWidgets/ColorMapCanvasEvent.h b/GUI/coregui/Views/IntensityDataWidgets/ColorMapCanvasEvent.h
index 3751a08f0e36f4cf08b99a3f38078447d7815d00..1fa49accef02a589299b91f49a8ddd62a7400efb 100644
--- a/GUI/coregui/Views/IntensityDataWidgets/ColorMapCanvasEvent.h
+++ b/GUI/coregui/Views/IntensityDataWidgets/ColorMapCanvasEvent.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/IntensityDataWidgets/ColorMapCanvasEvent.h
-//! @brief     Declares class ColorMapCanvasEvent
+//! @brief     Defines class ColorMapCanvasEvent
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/IntensityDataWidgets/ColorMapEvent.h b/GUI/coregui/Views/IntensityDataWidgets/ColorMapEvent.h
index d8eb5228d37996b0460c30de853546cb2966a184..470ce686311cd9b3850023e4e2bc66a3f2751ae9 100644
--- a/GUI/coregui/Views/IntensityDataWidgets/ColorMapEvent.h
+++ b/GUI/coregui/Views/IntensityDataWidgets/ColorMapEvent.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/IntensityDataWidgets/ColorMapEvent.h
-//! @brief     Declares class ColorMapEvent
+//! @brief     Defines class ColorMapEvent
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/IntensityDataWidgets/ColorMapHelper.h b/GUI/coregui/Views/IntensityDataWidgets/ColorMapHelper.h
index eaee82ee790d3af6e0131828fa8d30baf0171e03..91dd51c59086857e9977857b38f73042dc196268 100644
--- a/GUI/coregui/Views/IntensityDataWidgets/ColorMapHelper.h
+++ b/GUI/coregui/Views/IntensityDataWidgets/ColorMapHelper.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/IntensityDataWidgets/ColorMapHelper.h
-//! @brief     Declares class ColorMapHelper
+//! @brief     Defines class ColorMapHelper
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/IntensityDataWidgets/ColorMapLabel.h b/GUI/coregui/Views/IntensityDataWidgets/ColorMapLabel.h
index 7efb18a285c571f87951b86e20fd123e4595de05..55d0c7ce0fc3d05bad4ba471242c149d2dcc0fbe 100644
--- a/GUI/coregui/Views/IntensityDataWidgets/ColorMapLabel.h
+++ b/GUI/coregui/Views/IntensityDataWidgets/ColorMapLabel.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/IntensityDataWidgets/ColorMapLabel.h
-//! @brief     Declares class ColorMapLabel
+//! @brief     Defines class ColorMapLabel
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef COLORMAPLABEL_H
 #define COLORMAPLABEL_H
 
-#include "StatusLabel.h" // inheriting from
+#include "StatusLabel.h"
 #include <QList>
 
 class ColorMap;
diff --git a/GUI/coregui/Views/IntensityDataWidgets/ColorMapPlot.cpp b/GUI/coregui/Views/IntensityDataWidgets/ColorMapPlot.cpp
index 12b63e87847a2f74a3e1e5370b1d65974aadf664..27959a56a72d11be6d08263f6c69d8c48ef1650c 100644
--- a/GUI/coregui/Views/IntensityDataWidgets/ColorMapPlot.cpp
+++ b/GUI/coregui/Views/IntensityDataWidgets/ColorMapPlot.cpp
@@ -19,7 +19,7 @@
 #include "ColorMapHelper.h"
 #include "GUIHelpers.h"
 #include "IntensityDataItem.h"
-#include "Units.h"
+#include "Pi.h"
 #include "UpdateTimer.h"
 #include <QDebug>
 
diff --git a/GUI/coregui/Views/IntensityDataWidgets/ColorMapPlot.h b/GUI/coregui/Views/IntensityDataWidgets/ColorMapPlot.h
index 926db550d3c15cc5ed98845865db7c23ebfd163f..fb49c3d310b0a8c6890d0cd522c089e8d4ac3ff9 100644
--- a/GUI/coregui/Views/IntensityDataWidgets/ColorMapPlot.h
+++ b/GUI/coregui/Views/IntensityDataWidgets/ColorMapPlot.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/IntensityDataWidgets/ColorMapPlot.h
-//! @brief     Declares class ColorMapPlot
+//! @brief     Defines class ColorMapPlot
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/IntensityDataWidgets/HorizontalSlicePlot.cpp b/GUI/coregui/Views/IntensityDataWidgets/HorizontalSlicePlot.cpp
index 0aeff7ab28f07be67dda3f1624f443f77510d183..2dd4cfebd62f53e2564b9009cafa7b1b7a38e8c2 100644
--- a/GUI/coregui/Views/IntensityDataWidgets/HorizontalSlicePlot.cpp
+++ b/GUI/coregui/Views/IntensityDataWidgets/HorizontalSlicePlot.cpp
@@ -17,7 +17,7 @@
 #include "HorizontalSlicePlot.h"
 #include "AxesItems.h"
 #include "IntensityDataItem.h"
-#include "Units.h"
+#include "Pi.h"
 #include "qcustomplot.h"
 #include <QVBoxLayout>
 
diff --git a/GUI/coregui/Views/IntensityDataWidgets/HorizontalSlicePlot.h b/GUI/coregui/Views/IntensityDataWidgets/HorizontalSlicePlot.h
index efe861899ac9bf79bfbfcc0a85ef648f1b7effee..116ce31ed78695957d9af3c2b237f08fe3ad6ad9 100644
--- a/GUI/coregui/Views/IntensityDataWidgets/HorizontalSlicePlot.h
+++ b/GUI/coregui/Views/IntensityDataWidgets/HorizontalSlicePlot.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/IntensityDataWidgets/HorizontalSlicePlot.h
-//! @brief     Declares class HorizontalSlicePlot
+//! @brief     Defines class HorizontalSlicePlot
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/IntensityDataWidgets/IntensityDataPropertyWidget.h b/GUI/coregui/Views/IntensityDataWidgets/IntensityDataPropertyWidget.h
index 4a40c3bda7d13a42e9b03baf645b916221a23318..ba4685433c47d106a79a905e3037d9852abed94b 100644
--- a/GUI/coregui/Views/IntensityDataWidgets/IntensityDataPropertyWidget.h
+++ b/GUI/coregui/Views/IntensityDataWidgets/IntensityDataPropertyWidget.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/IntensityDataWidgets/IntensityDataPropertyWidget.h
-//! @brief     Declares class IntensityDataPropertyWidget
+//! @brief     Defines class IntensityDataPropertyWidget
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef INTENSITYDATAPROPERTYWIDGET_H
 #define INTENSITYDATAPROPERTYWIDGET_H
 
-#include "SessionItemWidget.h" // inheriting from
+#include "SessionItemWidget.h"
 
 class JobModel;
 class IntensityDataItem;
diff --git a/GUI/coregui/Views/IntensityDataWidgets/IntensityDataWidget.h b/GUI/coregui/Views/IntensityDataWidgets/IntensityDataWidget.h
index 3bb9479d5763d774d984ef52fc42851f2132affa..ef6124cf8eceb04ca8931943ec8cf1258abdbb0c 100644
--- a/GUI/coregui/Views/IntensityDataWidgets/IntensityDataWidget.h
+++ b/GUI/coregui/Views/IntensityDataWidgets/IntensityDataWidget.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/IntensityDataWidgets/IntensityDataWidget.h
-//! @brief     Declares class IntensityDataWidget
+//! @brief     Defines class IntensityDataWidget
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef INTENSITYDATAWIDGET_H
 #define INTENSITYDATAWIDGET_H
 
-#include "SessionItemWidget.h" // inheriting from
+#include "SessionItemWidget.h"
 
 class SessionItem;
 class IntensityDataItem;
diff --git a/GUI/coregui/Views/IntensityDataWidgets/ObsoleteIntensityDataPlotWidget.h b/GUI/coregui/Views/IntensityDataWidgets/ObsoleteIntensityDataPlotWidget.h
index 0643af4190faf06614920b0bb44a075dcbea8630..d4a74f85007b4e5dfd8018b364d4121ab146729b 100644
--- a/GUI/coregui/Views/IntensityDataWidgets/ObsoleteIntensityDataPlotWidget.h
+++ b/GUI/coregui/Views/IntensityDataWidgets/ObsoleteIntensityDataPlotWidget.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/IntensityDataWidgets/ObsoleteIntensityDataPlotWidget.h
-//! @brief     Declares class ObsoleteIntensityDataPlotWidget
+//! @brief     Defines class ObsoleteIntensityDataPlotWidget
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/IntensityDataWidgets/ObsoleteIntensityDataWidget.h b/GUI/coregui/Views/IntensityDataWidgets/ObsoleteIntensityDataWidget.h
index 03de6223a1314c48abb03b0405a4f37bd8c78244..b055902f966a08201964b59a48e50a8b5177d9ec 100644
--- a/GUI/coregui/Views/IntensityDataWidgets/ObsoleteIntensityDataWidget.h
+++ b/GUI/coregui/Views/IntensityDataWidgets/ObsoleteIntensityDataWidget.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/IntensityDataWidgets/ObsoleteIntensityDataWidget.h
-//! @brief     Declares class ObsoleteIntensityDataWidget
+//! @brief     Defines class ObsoleteIntensityDataWidget
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef OBSOLETEINTENSITYDATAWIDGET_H
 #define OBSOLETEINTENSITYDATAWIDGET_H
 
-#include "SessionItemWidget.h" // inheriting from
+#include "SessionItemWidget.h"
 
 class IntensityDataItem;
 class ObsoleteIntensityDataWidgetActions;
diff --git a/GUI/coregui/Views/IntensityDataWidgets/ObsoleteIntensityDataWidgetActions.h b/GUI/coregui/Views/IntensityDataWidgets/ObsoleteIntensityDataWidgetActions.h
index 6da1df67fbca970792e1b858b870a3aedaa138e4..b73fcbc2289d8852deadb9051ff495be737c0c2e 100644
--- a/GUI/coregui/Views/IntensityDataWidgets/ObsoleteIntensityDataWidgetActions.h
+++ b/GUI/coregui/Views/IntensityDataWidgets/ObsoleteIntensityDataWidgetActions.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/IntensityDataWidgets/ObsoleteIntensityDataWidgetActions.h
-//! @brief     Declares class ObsoleteIntensityDataWidgetActions
+//! @brief     Defines class ObsoleteIntensityDataWidgetActions
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/IntensityDataWidgets/SavePlotAssistant.h b/GUI/coregui/Views/IntensityDataWidgets/SavePlotAssistant.h
index 13d3bb9f7a7115f4395eb10b7f77b18c59d9f136..5e07979c0ba070d792be97860670590babf34789 100644
--- a/GUI/coregui/Views/IntensityDataWidgets/SavePlotAssistant.h
+++ b/GUI/coregui/Views/IntensityDataWidgets/SavePlotAssistant.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/IntensityDataWidgets/SavePlotAssistant.h
-//! @brief     Declares class SavePlotAssistant
+//! @brief     Defines class SavePlotAssistant
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/IntensityDataWidgets/VerticalSlicePlot.cpp b/GUI/coregui/Views/IntensityDataWidgets/VerticalSlicePlot.cpp
index 75249cc0a2a52e53de373c6822fc949a7eb3fe08..a7cb7abb3a25013ec6dc4e9ac296aebec3cf2c30 100644
--- a/GUI/coregui/Views/IntensityDataWidgets/VerticalSlicePlot.cpp
+++ b/GUI/coregui/Views/IntensityDataWidgets/VerticalSlicePlot.cpp
@@ -17,7 +17,7 @@
 #include "VerticalSlicePlot.h"
 #include "AxesItems.h"
 #include "IntensityDataItem.h"
-#include "Units.h"
+#include "Pi.h"
 #include "qcustomplot.h"
 #include <QVBoxLayout>
 
diff --git a/GUI/coregui/Views/IntensityDataWidgets/VerticalSlicePlot.h b/GUI/coregui/Views/IntensityDataWidgets/VerticalSlicePlot.h
index 39d05a1858d5e1a067feea32a85b28c213e98796..7d1bf7ae93d4a044f0329b24645745013bb8daa9 100644
--- a/GUI/coregui/Views/IntensityDataWidgets/VerticalSlicePlot.h
+++ b/GUI/coregui/Views/IntensityDataWidgets/VerticalSlicePlot.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/IntensityDataWidgets/VerticalSlicePlot.h
-//! @brief     Declares class VerticalSlicePlot
+//! @brief     Defines class VerticalSlicePlot
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/JobView.h b/GUI/coregui/Views/JobView.h
index 8a889dcba2b9daec3950b0df43a6ad2939aea8e8..456b5570792453f6377d2e4a76403769ffe9ad82 100644
--- a/GUI/coregui/Views/JobView.h
+++ b/GUI/coregui/Views/JobView.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/JobView.h
-//! @brief     Declares class JobView
+//! @brief     Defines class JobView
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/JobWidgets/JobActivityStatusBar.h b/GUI/coregui/Views/JobWidgets/JobActivityStatusBar.h
index 413d16fa35ffffb01aa62d49cc3016498403c216..ccae23877756770be6fd40bf0a2df60898a17382 100644
--- a/GUI/coregui/Views/JobWidgets/JobActivityStatusBar.h
+++ b/GUI/coregui/Views/JobWidgets/JobActivityStatusBar.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/JobWidgets/JobActivityStatusBar.h
-//! @brief     Declares class JobActivityStatusBar
+//! @brief     Defines class JobActivityStatusBar
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/JobWidgets/JobListViewDelegate.h b/GUI/coregui/Views/JobWidgets/JobListViewDelegate.h
index 1e19abd9af24461a80d9c63aad9773e526a81dfc..5db4390fa84d185cf1ed46a0f7765e51fadb3c73 100644
--- a/GUI/coregui/Views/JobWidgets/JobListViewDelegate.h
+++ b/GUI/coregui/Views/JobWidgets/JobListViewDelegate.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/JobWidgets/JobListViewDelegate.h
-//! @brief     Declares class JobListViewDelegate
+//! @brief     Defines class JobListViewDelegate
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/JobWidgets/JobListWidget.h b/GUI/coregui/Views/JobWidgets/JobListWidget.h
index 0255cf841631a04779b4d28793c7c8d4da8a44d1..5c7da398e7266fdc5a1e898e8ed126d9283736ad 100644
--- a/GUI/coregui/Views/JobWidgets/JobListWidget.h
+++ b/GUI/coregui/Views/JobWidgets/JobListWidget.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/JobWidgets/JobListWidget.h
-//! @brief     Declares class JobListWidget
+//! @brief     Defines class JobListWidget
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/JobWidgets/JobMessagePanel.h b/GUI/coregui/Views/JobWidgets/JobMessagePanel.h
index 0923cbfd2287f6b5f271d9dde8091c96ab1e324b..d7aabec37ffc8aea0504696715a333bee0049f55 100644
--- a/GUI/coregui/Views/JobWidgets/JobMessagePanel.h
+++ b/GUI/coregui/Views/JobWidgets/JobMessagePanel.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/JobWidgets/JobMessagePanel.h
-//! @brief     Declares class JobMessagePanel
+//! @brief     Defines class JobMessagePanel
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef JOBMESSAGEPANEL_H
 #define JOBMESSAGEPANEL_H
 
-#include "InfoPanel.h" // inheriting from
+#include "InfoPanel.h"
 #include <QColor>
 
 class QTextEdit;
diff --git a/GUI/coregui/Views/JobWidgets/JobOutputDataWidget.h b/GUI/coregui/Views/JobWidgets/JobOutputDataWidget.h
index deaeceef173c5a84449d567ae890e21fc6849e93..221e77bb2f1545641ea3e5f5e201b8e748ab7826 100644
--- a/GUI/coregui/Views/JobWidgets/JobOutputDataWidget.h
+++ b/GUI/coregui/Views/JobWidgets/JobOutputDataWidget.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/JobWidgets/JobOutputDataWidget.h
-//! @brief     Declares class JobOutputDataWidget
+//! @brief     Defines class JobOutputDataWidget
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/JobWidgets/JobProgressAssistant.h b/GUI/coregui/Views/JobWidgets/JobProgressAssistant.h
index ca0e5f32d3b85a34b086abb878da46b36fff11ef..561327d7b864be7c3bf7cede8e24e769cb005167 100644
--- a/GUI/coregui/Views/JobWidgets/JobProgressAssistant.h
+++ b/GUI/coregui/Views/JobWidgets/JobProgressAssistant.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/JobWidgets/JobProgressAssistant.h
-//! @brief     Declares class JobProgressAssistant
+//! @brief     Defines class JobProgressAssistant
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/JobWidgets/JobPropertiesWidget.h b/GUI/coregui/Views/JobWidgets/JobPropertiesWidget.h
index 57ecdee79ce1224ffbf2b53601af4d83053c3c0f..6682c2d6370585b0636cd3ba33c4bd631760b580 100644
--- a/GUI/coregui/Views/JobWidgets/JobPropertiesWidget.h
+++ b/GUI/coregui/Views/JobWidgets/JobPropertiesWidget.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/JobWidgets/JobPropertiesWidget.h
-//! @brief     Declares class JobPropertiesWidget
+//! @brief     Defines class JobPropertiesWidget
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/JobWidgets/JobRealTimeToolBar.h b/GUI/coregui/Views/JobWidgets/JobRealTimeToolBar.h
index 9b20f27a8c7f3d4587cfcd256c7afe437648e21e..cb7801d815074f821fabdb71a7dd7a846d6b9509 100644
--- a/GUI/coregui/Views/JobWidgets/JobRealTimeToolBar.h
+++ b/GUI/coregui/Views/JobWidgets/JobRealTimeToolBar.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/JobWidgets/JobRealTimeToolBar.h
-//! @brief     Declares class JobRealTimeToolBar
+//! @brief     Defines class JobRealTimeToolBar
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef JOBREALTIMETOOLBAR_H
 #define JOBREALTIMETOOLBAR_H
 
-#include "StyledToolBar.h" // inheriting from
+#include "StyledToolBar.h"
 
 //! The JobRealTimeToolBar class represents a toolbar with buttons for JobRealTimeWidget.
 
diff --git a/GUI/coregui/Views/JobWidgets/JobRealTimeWidget.h b/GUI/coregui/Views/JobWidgets/JobRealTimeWidget.h
index f895b80b9ca85490b0448a72b8b56ba94b2fb5be..788d39376c0e38860202b746d9626410ee653436 100644
--- a/GUI/coregui/Views/JobWidgets/JobRealTimeWidget.h
+++ b/GUI/coregui/Views/JobWidgets/JobRealTimeWidget.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/JobWidgets/JobRealTimeWidget.h
-//! @brief     Declares class JobRealTimeWidget
+//! @brief     Defines class JobRealTimeWidget
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/JobWidgets/JobResultsPresenter.h b/GUI/coregui/Views/JobWidgets/JobResultsPresenter.h
index 362cc9ea1db81f24febfba95290e0c193d358d5d..21f932a6d0179ec3f5be5229fb1f03a6c88a75d4 100644
--- a/GUI/coregui/Views/JobWidgets/JobResultsPresenter.h
+++ b/GUI/coregui/Views/JobWidgets/JobResultsPresenter.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/JobWidgets/JobResultsPresenter.h
-//! @brief     Declares class JobResultsPresenter
+//! @brief     Defines class JobResultsPresenter
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef JOBRESULTSPRESENTER_H
 #define JOBRESULTSPRESENTER_H
 
-#include "ItemComboWidget.h" // inheriting from
+#include "ItemComboWidget.h"
 
 //! The JobResultsPresenter class is a widget which is able to present results of job (JobItem)
 //! using stack of different widgets and combo box in the right top corner of JobView, to switch
diff --git a/GUI/coregui/Views/JobWidgets/JobSelectorActions.h b/GUI/coregui/Views/JobWidgets/JobSelectorActions.h
index 39c7db65c24ecc704933edc73d6f8c166e605a95..6227e5c164b7f59956d0b7285fde34080dd0d939 100644
--- a/GUI/coregui/Views/JobWidgets/JobSelectorActions.h
+++ b/GUI/coregui/Views/JobWidgets/JobSelectorActions.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/JobWidgets/JobSelectorActions.h
-//! @brief     Declares class JobSelectorActions
+//! @brief     Defines class JobSelectorActions
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/JobWidgets/JobSelectorWidget.h b/GUI/coregui/Views/JobWidgets/JobSelectorWidget.h
index d985adf8f426e34ad54a2667f55013b7f9924268..b60979cf2ed3b78dd3fdb195594515a30057ae2c 100644
--- a/GUI/coregui/Views/JobWidgets/JobSelectorWidget.h
+++ b/GUI/coregui/Views/JobWidgets/JobSelectorWidget.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/JobWidgets/JobSelectorWidget.h
-//! @brief     Declares class JobSelectorWidget
+//! @brief     Defines class JobSelectorWidget
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/JobWidgets/JobViewActivities.h b/GUI/coregui/Views/JobWidgets/JobViewActivities.h
index dc865197f59eb0e7de13db20c51c8a7c51a8f60b..985f98f00bb07bd2e9af59dab3e68dfe73baa1ad 100644
--- a/GUI/coregui/Views/JobWidgets/JobViewActivities.h
+++ b/GUI/coregui/Views/JobWidgets/JobViewActivities.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/JobWidgets/JobViewActivities.h
-//! @brief     Declares class JobViewActivities
+//! @brief     Defines class JobViewActivities
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/JobWidgets/JobViewDocks.h b/GUI/coregui/Views/JobWidgets/JobViewDocks.h
index 951393b6737a3fcdc4b55a5692159ee94443b33a..8094c284fcc0eddfbf60d53c14607c4e8274af7d 100644
--- a/GUI/coregui/Views/JobWidgets/JobViewDocks.h
+++ b/GUI/coregui/Views/JobWidgets/JobViewDocks.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/JobWidgets/JobViewDocks.h
-//! @brief     Declares class JobViewDocks
+//! @brief     Defines class JobViewDocks
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/JobWidgets/JobViewFlags.h b/GUI/coregui/Views/JobWidgets/JobViewFlags.h
index 32405ffd41428fa40fc31133cf40deb6164de6cd..467d682d4bcfdd1ed49879aea1203344885e21aa 100644
--- a/GUI/coregui/Views/JobWidgets/JobViewFlags.h
+++ b/GUI/coregui/Views/JobWidgets/JobViewFlags.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/JobWidgets/JobViewFlags.h
-//! @brief     Declares class JobViewFlags
+//! @brief     Defines class JobViewFlags
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/JobWidgets/ParameterTuningDelegate.h b/GUI/coregui/Views/JobWidgets/ParameterTuningDelegate.h
index 3c39fc4addf29df29545c91ee10f90f4e329df9a..681efa57afb80a367a4f4665464cee2ac95d57ef 100644
--- a/GUI/coregui/Views/JobWidgets/ParameterTuningDelegate.h
+++ b/GUI/coregui/Views/JobWidgets/ParameterTuningDelegate.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/JobWidgets/ParameterTuningDelegate.h
-//! @brief     Declares class ParameterTuningDelegate
+//! @brief     Defines class ParameterTuningDelegate
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/JobWidgets/ParameterTuningWidget.h b/GUI/coregui/Views/JobWidgets/ParameterTuningWidget.h
index 22158f7bdc462feb6859cbba7dec7d17ccddca62..fc77691fe7f63e7377e4a677657841f69f75d4fe 100644
--- a/GUI/coregui/Views/JobWidgets/ParameterTuningWidget.h
+++ b/GUI/coregui/Views/JobWidgets/ParameterTuningWidget.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/JobWidgets/ParameterTuningWidget.h
-//! @brief     Declares class ParameterTuningWidget
+//! @brief     Defines class ParameterTuningWidget
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/JobWidgets/SliderSettingsWidget.h b/GUI/coregui/Views/JobWidgets/SliderSettingsWidget.h
index 252d8d189e13f7ceb3c8ff73098e238eece2e33f..85ed65db50eef1523bddbc88f3cc880887b3900e 100644
--- a/GUI/coregui/Views/JobWidgets/SliderSettingsWidget.h
+++ b/GUI/coregui/Views/JobWidgets/SliderSettingsWidget.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/JobWidgets/SliderSettingsWidget.h
-//! @brief     Declares class SliderSettingsWidget
+//! @brief     Defines class SliderSettingsWidget
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/MaskWidgets/ColorMapSceneAdaptor.h b/GUI/coregui/Views/MaskWidgets/ColorMapSceneAdaptor.h
index ec8ff7e7e36889629f8486ea1ad6099939432196..61269983266e64d6e3e516d9c29d5ad3430e5293 100644
--- a/GUI/coregui/Views/MaskWidgets/ColorMapSceneAdaptor.h
+++ b/GUI/coregui/Views/MaskWidgets/ColorMapSceneAdaptor.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/MaskWidgets/ColorMapSceneAdaptor.h
-//! @brief     Declares class ColorMapSceneAdaptor
+//! @brief     Defines class ColorMapSceneAdaptor
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef COLORMAPSCENEADAPTOR_H
 #define COLORMAPSCENEADAPTOR_H
 
-#include "ISceneAdaptor.h" // inheriting from
+#include "ISceneAdaptor.h"
 
 class ColorMapPlot;
 
diff --git a/GUI/coregui/Views/MaskWidgets/EllipseView.h b/GUI/coregui/Views/MaskWidgets/EllipseView.h
index 2ce37eb8d9414463790aa17a5559ac24ae00731b..5bf891cbb0f23dca49befc1b48303c4baa763ec4 100644
--- a/GUI/coregui/Views/MaskWidgets/EllipseView.h
+++ b/GUI/coregui/Views/MaskWidgets/EllipseView.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/MaskWidgets/EllipseView.h
-//! @brief     Declares EllipseView class
+//! @brief     Defines EllipseView class
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef ELLIPSEVIEW_H
 #define ELLIPSEVIEW_H
 
-#include "IMaskView.h" // inheriting from
+#include "IMaskView.h"
 #include "SizeHandleElement.h"
 #include <QMap>
 
diff --git a/GUI/coregui/Views/MaskWidgets/IMaskView.h b/GUI/coregui/Views/MaskWidgets/IMaskView.h
index 456f2311e9b9e34a375314925e844e7ff6695b00..93d2fd3e7ff1e701b94cd97a9bde1224cd17e02f 100644
--- a/GUI/coregui/Views/MaskWidgets/IMaskView.h
+++ b/GUI/coregui/Views/MaskWidgets/IMaskView.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/MaskWidgets/IMaskView.h
-//! @brief     Declares interface class IMaskView for all masks on graphics scene
+//! @brief     Defines interface class IMaskView for all masks on graphics scene
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/MaskWidgets/ISceneAdaptor.h b/GUI/coregui/Views/MaskWidgets/ISceneAdaptor.h
index 246cedfba54b2f3801fdec6b0185b1adc9c3b004..9c6b63c76dd447295c52fffdc4b5123c4c5f63f6 100644
--- a/GUI/coregui/Views/MaskWidgets/ISceneAdaptor.h
+++ b/GUI/coregui/Views/MaskWidgets/ISceneAdaptor.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/MaskWidgets/ISceneAdaptor.h
-//! @brief     Declares interface class ISceneAdaptor
+//! @brief     Defines interface class ISceneAdaptor
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/MaskWidgets/IntensityDataView.h b/GUI/coregui/Views/MaskWidgets/IntensityDataView.h
index d1ea2b257e92bdb24cbabc32af8b9c671a770913..51f4f6331bfc5611eeeb18843224d231015d3da3 100644
--- a/GUI/coregui/Views/MaskWidgets/IntensityDataView.h
+++ b/GUI/coregui/Views/MaskWidgets/IntensityDataView.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/MaskWidgets/IntensityDataView.h
-//! @brief     Declares IntensityDataView class
+//! @brief     Defines IntensityDataView class
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef INTENSITYDATAVIEW_H
 #define INTENSITYDATAVIEW_H
 
-#include "IMaskView.h" // inheriting from
+#include "IMaskView.h"
 #include "SizeHandleElement.h"
 #include <QMap>
 
diff --git a/GUI/coregui/Views/MaskWidgets/LineViews.h b/GUI/coregui/Views/MaskWidgets/LineViews.h
index 5ab78a4fc54826c39eba9ec86842cd2181164e99..3a9914ef0fe007b77b1b0ca5d540bfba23c1e1bf 100644
--- a/GUI/coregui/Views/MaskWidgets/LineViews.h
+++ b/GUI/coregui/Views/MaskWidgets/LineViews.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/MaskWidgets/LineViews.h
-//! @brief     Declares classes VerticalLineView and HorizontalLineView
+//! @brief     Defines classes VerticalLineView and HorizontalLineView
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef LINEVIEWS_H
 #define LINEVIEWS_H
 
-#include "IMaskView.h" // inheriting from
+#include "IMaskView.h"
 
 //! This is a view of VerticalLineItem mask
 
diff --git a/GUI/coregui/Views/MaskWidgets/MaskAllView.h b/GUI/coregui/Views/MaskWidgets/MaskAllView.h
index fb5566e96295bf463c2687cddcb6fb152797f40b..ffbd03e7e831a2706bce9d0fd142c3090d512f84 100644
--- a/GUI/coregui/Views/MaskWidgets/MaskAllView.h
+++ b/GUI/coregui/Views/MaskWidgets/MaskAllView.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/MaskWidgets/MaskAllView.h
-//! @brief     Declares MaskAllView class
+//! @brief     Defines MaskAllView class
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef MASKALLVIEW_H
 #define MASKALLVIEW_H
 
-#include "IMaskView.h" // inheriting from
+#include "IMaskView.h"
 
 //! This is a view of MaskAllItem which covers whole detector plane with mask value=true.
 
diff --git a/GUI/coregui/Views/MaskWidgets/MaskContainerView.h b/GUI/coregui/Views/MaskWidgets/MaskContainerView.h
index a7e7798471d78d2dd3e5feebd4aaca2b176921cf..d87d244e3bb6d1a56c1c5f85031f3faa8dcdb3aa 100644
--- a/GUI/coregui/Views/MaskWidgets/MaskContainerView.h
+++ b/GUI/coregui/Views/MaskWidgets/MaskContainerView.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/MaskWidgets/MaskContainerView.h
-//! @brief     Declares MaskContainerView class
+//! @brief     Defines MaskContainerView class
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef MASKCONTAINERVIEW_H
 #define MASKCONTAINERVIEW_H
 
-#include "IMaskView.h" // inheriting from
+#include "IMaskView.h"
 #include "SizeHandleElement.h"
 #include <QMap>
 
diff --git a/GUI/coregui/Views/MaskWidgets/MaskDrawingContext.h b/GUI/coregui/Views/MaskWidgets/MaskDrawingContext.h
index fb70677983a92a4ac905e57ea9de3aea23d4b854..91a6841992213d7e8ee330bbeff6adcf7185563e 100644
--- a/GUI/coregui/Views/MaskWidgets/MaskDrawingContext.h
+++ b/GUI/coregui/Views/MaskWidgets/MaskDrawingContext.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/MaskWidgets/MaskDrawingContext.h
-//! @brief     Declares class MaskDrawingContext
+//! @brief     Defines class MaskDrawingContext
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/MaskWidgets/MaskEditor.h b/GUI/coregui/Views/MaskWidgets/MaskEditor.h
index 12e2926eb1b00e7f50bbf9d0399da72379634127..edbbcf3bc7b859a8335469abf7508a21a7bca22b 100644
--- a/GUI/coregui/Views/MaskWidgets/MaskEditor.h
+++ b/GUI/coregui/Views/MaskWidgets/MaskEditor.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/MaskWidgets/MaskEditor.h
-//! @brief     Declares class MaskEditor
+//! @brief     Defines class MaskEditor
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/MaskWidgets/MaskEditorActions.h b/GUI/coregui/Views/MaskWidgets/MaskEditorActions.h
index 2636331edc3252e9f4a9fcec72f84965fb37dda3..1f6532c36eec0c5130e65d996b1efdcc4c68e733 100644
--- a/GUI/coregui/Views/MaskWidgets/MaskEditorActions.h
+++ b/GUI/coregui/Views/MaskWidgets/MaskEditorActions.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/MaskWidgets/MaskEditorActions.h
-//! @brief     Declares class MaskEditorActions
+//! @brief     Defines class MaskEditorActions
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/MaskWidgets/MaskEditorCanvas.h b/GUI/coregui/Views/MaskWidgets/MaskEditorCanvas.h
index a93fb3c314d0b10a8da8931efb508b00e9c156e7..647ee3096bbf681018eb4900036ca87cb5cbf46f 100644
--- a/GUI/coregui/Views/MaskWidgets/MaskEditorCanvas.h
+++ b/GUI/coregui/Views/MaskWidgets/MaskEditorCanvas.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/MaskWidgets/MaskEditorCanvas.h
-//! @brief     Declares class MaskEditorCanvas
+//! @brief     Defines class MaskEditorCanvas
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/MaskWidgets/MaskEditorFlags.h b/GUI/coregui/Views/MaskWidgets/MaskEditorFlags.h
index e24a3f70f95c779c261538264877bb649aad9b97..a4d6c019ef674c1ed858570de7795ccd0f788451 100644
--- a/GUI/coregui/Views/MaskWidgets/MaskEditorFlags.h
+++ b/GUI/coregui/Views/MaskWidgets/MaskEditorFlags.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/MaskWidgets/MaskEditorFlags.h
-//! @brief     Declares class MaskEditorFlags
+//! @brief     Defines class MaskEditorFlags
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/MaskWidgets/MaskEditorHelper.h b/GUI/coregui/Views/MaskWidgets/MaskEditorHelper.h
index 01a2fed3633ba39d3c377079c20f8d47fbe8ed0b..ea90b4ceb93bf3808544048ffe6d565461e8ed65 100644
--- a/GUI/coregui/Views/MaskWidgets/MaskEditorHelper.h
+++ b/GUI/coregui/Views/MaskWidgets/MaskEditorHelper.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/MaskWidgets/MaskEditorHelper.h
-//! @brief     Declares class MaskEditorHelper
+//! @brief     Defines class MaskEditorHelper
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/MaskWidgets/MaskEditorPropertyPanel.h b/GUI/coregui/Views/MaskWidgets/MaskEditorPropertyPanel.h
index 94e2c9f897f062270ea93ad0a98782bb2991c1de..536d2f0cb4cde056f1c09789767477230ed7a3ba 100644
--- a/GUI/coregui/Views/MaskWidgets/MaskEditorPropertyPanel.h
+++ b/GUI/coregui/Views/MaskWidgets/MaskEditorPropertyPanel.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/MaskWidgets/MaskEditorPropertyPanel.h
-//! @brief     Declares class MaskEditorPropertyPanel
+//! @brief     Defines class MaskEditorPropertyPanel
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/MaskWidgets/MaskEditorToolBar.h b/GUI/coregui/Views/MaskWidgets/MaskEditorToolBar.h
index 67acb9df0aa2d56e8990285c45d96bd72199f5af..15b8db8ea368d5d85964ccc77b73e03993835437 100644
--- a/GUI/coregui/Views/MaskWidgets/MaskEditorToolBar.h
+++ b/GUI/coregui/Views/MaskWidgets/MaskEditorToolBar.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/MaskWidgets/MaskEditorToolBar.h
-//! @brief     Declares class MaskEditorToolBar
+//! @brief     Defines class MaskEditorToolBar
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/MaskWidgets/MaskGraphicsProxy.h b/GUI/coregui/Views/MaskWidgets/MaskGraphicsProxy.h
index 667cd249df1c8dd0ea11585a3fa13e8ff13be1c2..45c3291d946f1a866d95f9923d69e77ea8107776 100644
--- a/GUI/coregui/Views/MaskWidgets/MaskGraphicsProxy.h
+++ b/GUI/coregui/Views/MaskWidgets/MaskGraphicsProxy.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/MaskWidgets/MaskGraphicsProxy.h
-//! @brief     Declares class MaskGraphicsProxy
+//! @brief     Defines class MaskGraphicsProxy
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/MaskWidgets/MaskGraphicsScene.h b/GUI/coregui/Views/MaskWidgets/MaskGraphicsScene.h
index 17b9fb74a3daea4cded12342e8441cf08f426520..06080597d0155d53265b221be843f75eb794d840 100644
--- a/GUI/coregui/Views/MaskWidgets/MaskGraphicsScene.h
+++ b/GUI/coregui/Views/MaskWidgets/MaskGraphicsScene.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/MaskWidgets/MaskGraphicsScene.h
-//! @brief     Declares class MaskGraphicsScene
+//! @brief     Defines class MaskGraphicsScene
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/MaskWidgets/MaskGraphicsView.h b/GUI/coregui/Views/MaskWidgets/MaskGraphicsView.h
index bc0c3f620abfde2d05cf3a875590159b8bf1d61a..98cc6e2c941a3b0368a1e7ea76c1d374f0a43034 100644
--- a/GUI/coregui/Views/MaskWidgets/MaskGraphicsView.h
+++ b/GUI/coregui/Views/MaskWidgets/MaskGraphicsView.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/MaskWidgets/MaskGraphicsView.h
-//! @brief     Declares class MaskGraphicsView
+//! @brief     Defines class MaskGraphicsView
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/MaskWidgets/MaskResultsPresenter.h b/GUI/coregui/Views/MaskWidgets/MaskResultsPresenter.h
index c838fd917d8495b47d2e410b056ef1f2f4a4c7e0..e9b640df68bf93bfeed2980c54e7341ad30eeaaf 100644
--- a/GUI/coregui/Views/MaskWidgets/MaskResultsPresenter.h
+++ b/GUI/coregui/Views/MaskWidgets/MaskResultsPresenter.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/MaskWidgets/MaskResultsPresenter.h
-//! @brief     Declares class MaskResultsPresenter
+//! @brief     Defines class MaskResultsPresenter
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/MaskWidgets/MaskViewFactory.h b/GUI/coregui/Views/MaskWidgets/MaskViewFactory.h
index bf6b93cc6d9cf3721af3af02dd306824870ace16..9ac84434b1c4ca6fe928783300936906eff0dd5e 100644
--- a/GUI/coregui/Views/MaskWidgets/MaskViewFactory.h
+++ b/GUI/coregui/Views/MaskWidgets/MaskViewFactory.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/MaskWidgets/MaskViewFactory.h
-//! @brief     Declares class MaskViewFactory
+//! @brief     Defines class MaskViewFactory
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/MaskWidgets/PolygonPointView.h b/GUI/coregui/Views/MaskWidgets/PolygonPointView.h
index b853cc3c8ee9c051a7d2000bedfefc7b452a89f6..67e6e833712477f1adc99a3b869bf732c7ad9767 100644
--- a/GUI/coregui/Views/MaskWidgets/PolygonPointView.h
+++ b/GUI/coregui/Views/MaskWidgets/PolygonPointView.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/MaskWidgets/PolygonPointView.h
-//! @brief     Declares PolygonPointView class
+//! @brief     Defines PolygonPointView class
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef POLYGONPOINTVIEW_H
 #define POLYGONPOINTVIEW_H
 
-#include "IMaskView.h" // inheriting from
+#include "IMaskView.h"
 
 //! This is a View of polygon point for PolygonMaskItem
 
diff --git a/GUI/coregui/Views/MaskWidgets/PolygonView.h b/GUI/coregui/Views/MaskWidgets/PolygonView.h
index ea8b9127eacabc94e4b095e1317d3350cc39454b..5e0b3e53767029b1822d29fa949397572cb6a5cc 100644
--- a/GUI/coregui/Views/MaskWidgets/PolygonView.h
+++ b/GUI/coregui/Views/MaskWidgets/PolygonView.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/MaskWidgets/PolygonView.h
-//! @brief     Declares PolygonView class
+//! @brief     Defines PolygonView class
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef POLYGONVIEW_H
 #define POLYGONVIEW_H
 
-#include "IMaskView.h" // inheriting from
+#include "IMaskView.h"
 #include <QPolygonF>
 
 //! This is a View of polygon mask (represented by PolygonItem) on GraphicsScene.
diff --git a/GUI/coregui/Views/MaskWidgets/RectangleView.h b/GUI/coregui/Views/MaskWidgets/RectangleView.h
index 233035b7e748aeff1c1b95376f5ff0156c87f3f9..5b0fd41f68ca52e0d6986477b01adb1d4e915dc5 100644
--- a/GUI/coregui/Views/MaskWidgets/RectangleView.h
+++ b/GUI/coregui/Views/MaskWidgets/RectangleView.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/MaskWidgets/RectangleView.h
-//! @brief     Declares RectangleView class
+//! @brief     Defines RectangleView class
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef RECTANGLEVIEW_H
 #define RECTANGLEVIEW_H
 
-#include "IMaskView.h" // inheriting from
+#include "IMaskView.h"
 #include "SizeHandleElement.h"
 #include <QMap>
 
diff --git a/GUI/coregui/Views/MaskWidgets/SizeHandleElement.h b/GUI/coregui/Views/MaskWidgets/SizeHandleElement.h
index e121c818924ce0f2d0ee44e469959ba0eb1efeaa..3ed1059e75e4ac0f7405d721d4035b900164d8c9 100644
--- a/GUI/coregui/Views/MaskWidgets/SizeHandleElement.h
+++ b/GUI/coregui/Views/MaskWidgets/SizeHandleElement.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/MaskWidgets/SizeHandleElement.h
-//! @brief     Declares SizeHandleElement class
+//! @brief     Defines SizeHandleElement class
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/MaterialEditor/MaterialEditor.h b/GUI/coregui/Views/MaterialEditor/MaterialEditor.h
index d3c55a15793299a3b9ec8dcfd0c7e9c0eacd7b71..048f431e720b09fb4ede7e0a47cf953de871a990 100644
--- a/GUI/coregui/Views/MaterialEditor/MaterialEditor.h
+++ b/GUI/coregui/Views/MaterialEditor/MaterialEditor.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/MaterialEditor/MaterialEditor.h
-//! @brief     Declares class MaterialEditor
+//! @brief     Defines class MaterialEditor
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/MaterialEditor/MaterialEditorDialog.h b/GUI/coregui/Views/MaterialEditor/MaterialEditorDialog.h
index 9b85700967271a07b068bcc23073cba3f3cb3268..99e90d9301e1f6d711befdffc432abd70584b983 100644
--- a/GUI/coregui/Views/MaterialEditor/MaterialEditorDialog.h
+++ b/GUI/coregui/Views/MaterialEditor/MaterialEditorDialog.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/MaterialEditor/MaterialEditorDialog.h
-//! @brief     Declares class MaterialEditorDialog
+//! @brief     Defines class MaterialEditorDialog
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/MaterialEditor/MaterialEditorToolBar.h b/GUI/coregui/Views/MaterialEditor/MaterialEditorToolBar.h
index 7cdaa9c835ff2dbc7de94310f38724cc97d6a076..74871999969b8a84e1f9950711744bffcd16cb1b 100644
--- a/GUI/coregui/Views/MaterialEditor/MaterialEditorToolBar.h
+++ b/GUI/coregui/Views/MaterialEditor/MaterialEditorToolBar.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/MaterialEditor/MaterialEditorToolBar.h
-//! @brief     Declares class MaterialEditorToolBar
+//! @brief     Defines class MaterialEditorToolBar
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/MaterialEditor/MaterialProperty.h b/GUI/coregui/Views/MaterialEditor/MaterialProperty.h
index 7fe13486e79e732067089ae67b7bb68c30e9cc14..a4ab5e1e36e78d912ebdcf29e915a6a2eecc9c84 100644
--- a/GUI/coregui/Views/MaterialEditor/MaterialProperty.h
+++ b/GUI/coregui/Views/MaterialEditor/MaterialProperty.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/MaterialEditor/MaterialProperty.h
-//! @brief     Declares class MaterialProperty
+//! @brief     Defines class MaterialProperty
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/MaterialEditor/MaterialSvc.h b/GUI/coregui/Views/MaterialEditor/MaterialSvc.h
index bc7182b57e7fbbe2eabad29e9be0e02170849029..7e41392813374ddd5c92ee70fb82e1f44eafb426 100644
--- a/GUI/coregui/Views/MaterialEditor/MaterialSvc.h
+++ b/GUI/coregui/Views/MaterialEditor/MaterialSvc.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/MaterialEditor/MaterialSvc.h
-//! @brief     Declares class MaterialSvc
+//! @brief     Defines class MaterialSvc
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/MaterialEditor/MaterialUtils.h b/GUI/coregui/Views/MaterialEditor/MaterialUtils.h
index d90032a5de32fa412b29d7c066c07c0fd90c79fb..0e13b36bd902f43df45bc5dd5df233cc962f148d 100644
--- a/GUI/coregui/Views/MaterialEditor/MaterialUtils.h
+++ b/GUI/coregui/Views/MaterialEditor/MaterialUtils.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/MaterialEditor/MaterialUtils.h
-//! @brief     Declares class MaterialUtils
+//! @brief     Defines class MaterialUtils
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/PropertyEditor/ComponentBoxEditor.h b/GUI/coregui/Views/PropertyEditor/ComponentBoxEditor.h
index 71c91a4854217e9b219de98ccde533ee7d4fda42..225e02abf80100ba334cd9cccd7e7f125e418124 100644
--- a/GUI/coregui/Views/PropertyEditor/ComponentBoxEditor.h
+++ b/GUI/coregui/Views/PropertyEditor/ComponentBoxEditor.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/PropertyEditor/ComponentBoxEditor.h
-//! @brief     Declares class ComponentBoxEditor
+//! @brief     Defines class ComponentBoxEditor
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef COMPONENTBOXEDITOR_H
 #define COMPONENTBOXEDITOR_H
 
-#include "ComponentEditor.h" // inheriting from
+#include "ComponentEditor.h"
 #include "WinDllMacros.h"
 
 //! Special version of editor to show property item as standard qt widgets
diff --git a/GUI/coregui/Views/PropertyEditor/ComponentEditor.h b/GUI/coregui/Views/PropertyEditor/ComponentEditor.h
index 9d6d11e829938ba373105444835ca8ab6e03d8c8..00a0d2ba83205824ed137e9473735ab8c2d46b81 100644
--- a/GUI/coregui/Views/PropertyEditor/ComponentEditor.h
+++ b/GUI/coregui/Views/PropertyEditor/ComponentEditor.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/PropertyEditor/ComponentEditor.h
-//! @brief     Declares class ComponentEditor
+//! @brief     Defines class ComponentEditor
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/PropertyEditor/ComponentEditorFlags.h b/GUI/coregui/Views/PropertyEditor/ComponentEditorFlags.h
index 9b3c961257c66057f856056b46b5c7d6043ebac4..b9f6b8c9fe5324674fda219ce15954d7d5894bda 100644
--- a/GUI/coregui/Views/PropertyEditor/ComponentEditorFlags.h
+++ b/GUI/coregui/Views/PropertyEditor/ComponentEditorFlags.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/PropertyEditor/ComponentEditorFlags.h
-//! @brief     Declares class ComponentEditorFlags
+//! @brief     Defines class ComponentEditorFlags
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/PropertyEditor/ComponentEditorPrivate.h b/GUI/coregui/Views/PropertyEditor/ComponentEditorPrivate.h
index deda1b1ebdf6b5c986f470d65a032c3f7f12da17..80f177780306579bb23dfcb8d4a5faeebaa37fcd 100644
--- a/GUI/coregui/Views/PropertyEditor/ComponentEditorPrivate.h
+++ b/GUI/coregui/Views/PropertyEditor/ComponentEditorPrivate.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/PropertyEditor/ComponentEditorPrivate.h
-//! @brief     Declares class ComponentEditorPrivate
+//! @brief     Defines class ComponentEditorPrivate
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/PropertyEditor/PropertyBrowserUtils.h b/GUI/coregui/Views/PropertyEditor/PropertyBrowserUtils.h
index 408d54e505738084e8f0acd9511c9a53cc5a2a47..d5998b9579fb100e4341534bcba8705ce97143e5 100644
--- a/GUI/coregui/Views/PropertyEditor/PropertyBrowserUtils.h
+++ b/GUI/coregui/Views/PropertyEditor/PropertyBrowserUtils.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/PropertyEditor/PropertyBrowserUtils.h
-//! @brief     Declares class PropertyBrowserUtils
+//! @brief     Defines class PropertyBrowserUtils
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/PropertyEditor/PropertyVariantFactory.h b/GUI/coregui/Views/PropertyEditor/PropertyVariantFactory.h
index 79a15cd284c77deafb7a7c7f01963ecfd904fe33..8ba25f7457d198faaf40b75e1066bcd2b149cd92 100644
--- a/GUI/coregui/Views/PropertyEditor/PropertyVariantFactory.h
+++ b/GUI/coregui/Views/PropertyEditor/PropertyVariantFactory.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/PropertyEditor/PropertyVariantFactory.h
-//! @brief     Declares class PropertyVariantFactory
+//! @brief     Defines class PropertyVariantFactory
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/PropertyEditor/PropertyVariantManager.h b/GUI/coregui/Views/PropertyEditor/PropertyVariantManager.h
index a01fdab8c4ffc7f95df5a8d6cfcf93d124ead67f..3323aa6c1d6eac8edd4f6a0e3d1f47123059badc 100644
--- a/GUI/coregui/Views/PropertyEditor/PropertyVariantManager.h
+++ b/GUI/coregui/Views/PropertyEditor/PropertyVariantManager.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/PropertyEditor/PropertyVariantManager.h
-//! @brief     Declares class PropertyVariantManager
+//! @brief     Defines class PropertyVariantManager
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/SampleDesigner/ConnectableView.h b/GUI/coregui/Views/SampleDesigner/ConnectableView.h
index ed081750b7471eb5ed3d35868cfc0d8764fce732..3af8342b03b1049a3d00ce8c6354f8dbf8fe649e 100644
--- a/GUI/coregui/Views/SampleDesigner/ConnectableView.h
+++ b/GUI/coregui/Views/SampleDesigner/ConnectableView.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/SampleDesigner/ConnectableView.h
-//! @brief     Declares class ConnectableView
+//! @brief     Defines class ConnectableView
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef CONNECTABLEVIEW_H
 #define CONNECTABLEVIEW_H
 
-#include "IView.h" // inheriting from
+#include "IView.h"
 #include "NodeEditorPort.h"
 #include "WinDllMacros.h"
 
diff --git a/GUI/coregui/Views/SampleDesigner/DesignerHelper.h b/GUI/coregui/Views/SampleDesigner/DesignerHelper.h
index 37033fa8ad879e4aa5a28db232c530d6d679e8cc..a893a2a49a98d0937e59b91269a2e991a00a2a85 100644
--- a/GUI/coregui/Views/SampleDesigner/DesignerHelper.h
+++ b/GUI/coregui/Views/SampleDesigner/DesignerHelper.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/SampleDesigner/DesignerHelper.h
-//! @brief     Declares class DesignerHelper
+//! @brief     Defines class DesignerHelper
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/SampleDesigner/DesignerMimeData.h b/GUI/coregui/Views/SampleDesigner/DesignerMimeData.h
index 38a8658704e5cd81db43179b4aa1f436d9631661..dcfe16c3608e184d96a58c161c1fc1826b342c06 100644
--- a/GUI/coregui/Views/SampleDesigner/DesignerMimeData.h
+++ b/GUI/coregui/Views/SampleDesigner/DesignerMimeData.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/SampleDesigner/DesignerMimeData.h
-//! @brief     Declares class DesignerMimeData
+//! @brief     Defines class DesignerMimeData
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/SampleDesigner/DesignerScene.h b/GUI/coregui/Views/SampleDesigner/DesignerScene.h
index d5b552c55424694e0ccb278a9b156fdac0402bbd..83873309f71aeea46a287493015252171f3643c9 100644
--- a/GUI/coregui/Views/SampleDesigner/DesignerScene.h
+++ b/GUI/coregui/Views/SampleDesigner/DesignerScene.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/SampleDesigner/DesignerScene.h
-//! @brief     Declares class DesignerScene
+//! @brief     Defines class DesignerScene
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/SampleDesigner/DesignerView.h b/GUI/coregui/Views/SampleDesigner/DesignerView.h
index bc8d9862934faf95c7d33c59dcb1d8cea83cc9ae..f90628dcfe8daa4ebb73f2b3f4548f2f9e49929a 100644
--- a/GUI/coregui/Views/SampleDesigner/DesignerView.h
+++ b/GUI/coregui/Views/SampleDesigner/DesignerView.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/SampleDesigner/DesignerView.h
-//! @brief     Declares class DesignerView
+//! @brief     Defines class DesignerView
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/SampleDesigner/ILayerView.h b/GUI/coregui/Views/SampleDesigner/ILayerView.h
index ead4af93a15d84c3a96dd8c4a0a7028926356e70..0e549bfc530236cd729668cb7ae2fcd07032c872 100644
--- a/GUI/coregui/Views/SampleDesigner/ILayerView.h
+++ b/GUI/coregui/Views/SampleDesigner/ILayerView.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/SampleDesigner/ILayerView.h
-//! @brief     Declares class ILayerView
+//! @brief     Defines class ILayerView
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef ILAYERVIEW_H
 #define ILAYERVIEW_H
 
-#include "ConnectableView.h" // inheriting from
+#include "ConnectableView.h"
 
 class MultiLayerView;
 class MultiLayerCandidate;
diff --git a/GUI/coregui/Views/SampleDesigner/IView.h b/GUI/coregui/Views/SampleDesigner/IView.h
index 79f3a94241bbf3039a8806b8833555ed509b42e1..259e52f2db6824d337b8180510ff8732be6ff71c 100644
--- a/GUI/coregui/Views/SampleDesigner/IView.h
+++ b/GUI/coregui/Views/SampleDesigner/IView.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/SampleDesigner/IView.h
-//! @brief     Declares class IView
+//! @brief     Defines class IView
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/SampleDesigner/InterferenceFunctionViews.h b/GUI/coregui/Views/SampleDesigner/InterferenceFunctionViews.h
index 26bab636c8c4c3fe6edb58f8540d3d4c61d427a1..703ae278671951f6332721ba1f4906ec25f76b81 100644
--- a/GUI/coregui/Views/SampleDesigner/InterferenceFunctionViews.h
+++ b/GUI/coregui/Views/SampleDesigner/InterferenceFunctionViews.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/SampleDesigner/InterferenceFunctionViews.h
-//! @brief     Declares classes InterferenceFunctionViews
+//! @brief     Defines classes InterferenceFunctionViews
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -18,7 +18,7 @@
 #define INTERFERENCEFUNCTIONVIEWS_H
 
 
-#include "ConnectableView.h" // inheriting from
+#include "ConnectableView.h"
 
 class BA_CORE_API_ InterferenceFunctionRadialParaCrystalView : public ConnectableView
 {
diff --git a/GUI/coregui/Views/SampleDesigner/ItemTreeView.h b/GUI/coregui/Views/SampleDesigner/ItemTreeView.h
index 6cc4f396c838006b5cdadcb72fc31210420e5b4e..59ff347ae3adaaf95fa93099e345911579f94c8a 100644
--- a/GUI/coregui/Views/SampleDesigner/ItemTreeView.h
+++ b/GUI/coregui/Views/SampleDesigner/ItemTreeView.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/SampleDesigner/ItemTreeView.h
-//! @brief     Declares class ItemTreeView
+//! @brief     Defines class ItemTreeView
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/SampleDesigner/LayerView.h b/GUI/coregui/Views/SampleDesigner/LayerView.h
index a91fbb16442662c8483cda2e7cf8c6cd7ad1c254..4987d403f1bc6009c2d94aa8b1dd2437b294c8df 100644
--- a/GUI/coregui/Views/SampleDesigner/LayerView.h
+++ b/GUI/coregui/Views/SampleDesigner/LayerView.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/SampleDesigner/LayerView.h
-//! @brief     Declares class LayerView
+//! @brief     Defines class LayerView
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef LAYERVIEW_H
 #define LAYERVIEW_H
 
-#include "ILayerView.h" // inheriting from
+#include "ILayerView.h"
 
 //! Class that represents view of Layer
 class BA_CORE_API_ LayerView : public ILayerView
diff --git a/GUI/coregui/Views/SampleDesigner/MultiLayerView.h b/GUI/coregui/Views/SampleDesigner/MultiLayerView.h
index 38ef7af42b7042beecffa60031d54f87077fb7fc..66962f1bba77cea8655585a3f30d0e5528298a37 100644
--- a/GUI/coregui/Views/SampleDesigner/MultiLayerView.h
+++ b/GUI/coregui/Views/SampleDesigner/MultiLayerView.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/SampleDesigner/MultiLayerView.h
-//! @brief     Declares class MultiLayerView
+//! @brief     Defines class MultiLayerView
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -18,7 +18,7 @@
 #define MULTILAYERVIEW_H
 
 
-#include "ILayerView.h" // inheriting from
+#include "ILayerView.h"
 
 class DesignerMimeData;
 class QGraphicsSceneDragDropEvent;
diff --git a/GUI/coregui/Views/SampleDesigner/NodeEditor.h b/GUI/coregui/Views/SampleDesigner/NodeEditor.h
index 031d896f7d87fd816019461943e8b0fed6d486ef..adb5c55e10e2acdabe245b9e0a49f58f696dcb4a 100644
--- a/GUI/coregui/Views/SampleDesigner/NodeEditor.h
+++ b/GUI/coregui/Views/SampleDesigner/NodeEditor.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/SampleDesigner/NodeEditor.h
-//! @brief     Declares class NodeEditor
+//! @brief     Defines class NodeEditor
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/SampleDesigner/NodeEditorConnection.h b/GUI/coregui/Views/SampleDesigner/NodeEditorConnection.h
index 9d1e8d75b33ce16f285d5a589ffc69860286135e..724af02ec1107d6ba83f3af1dd12dc43824d24ab 100644
--- a/GUI/coregui/Views/SampleDesigner/NodeEditorConnection.h
+++ b/GUI/coregui/Views/SampleDesigner/NodeEditorConnection.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/SampleDesigner/NodeEditorConnection.h
-//! @brief     Declares class NodeEditorConnection
+//! @brief     Defines class NodeEditorConnection
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/SampleDesigner/NodeEditorPort.h b/GUI/coregui/Views/SampleDesigner/NodeEditorPort.h
index 849ac5803717839c28a707c183be458b602387e7..1b2479c89e1cc2300f08bdbd9925086064042193 100644
--- a/GUI/coregui/Views/SampleDesigner/NodeEditorPort.h
+++ b/GUI/coregui/Views/SampleDesigner/NodeEditorPort.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/SampleDesigner/NodeEditorPort.h
-//! @brief     Declares class NodeEditorPort
+//! @brief     Defines class NodeEditorPort
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/SampleDesigner/ParticleCompositionView.h b/GUI/coregui/Views/SampleDesigner/ParticleCompositionView.h
index 1884856cc3252520a90a66872cc48fa6e5393f87..ef678edcae57cec8447ff120354aa77cc601847c 100644
--- a/GUI/coregui/Views/SampleDesigner/ParticleCompositionView.h
+++ b/GUI/coregui/Views/SampleDesigner/ParticleCompositionView.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/SampleDesigner/ParticleCompositionView.h
-//! @brief     Declares class ParticleCompositionView
+//! @brief     Defines class ParticleCompositionView
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef PARTICLECOMPOSITIONVIEW_H
 #define PARTICLECOMPOSITIONVIEW_H
 
-#include "ConnectableView.h" // inheriting from
+#include "ConnectableView.h"
 
 //! Class representing view of Particle item
 class BA_CORE_API_ ParticleCompositionView : public ConnectableView
diff --git a/GUI/coregui/Views/SampleDesigner/ParticleCoreShellView.h b/GUI/coregui/Views/SampleDesigner/ParticleCoreShellView.h
index cb6e763e285e40ed1f1abcf15fb6f27ec6d68946..37ad376d3a275f4a5b9a5575397bdd74acb9bf9e 100644
--- a/GUI/coregui/Views/SampleDesigner/ParticleCoreShellView.h
+++ b/GUI/coregui/Views/SampleDesigner/ParticleCoreShellView.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/SampleDesigner/ParticleCoreShellView.h
-//! @brief     Declares class ParticleCoreShellView
+//! @brief     Defines class ParticleCoreShellView
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef PARTICLECORESHELLVIEW_H
 #define PARTICLECORESHELLVIEW_H
 
-#include "ConnectableView.h" // inheriting from
+#include "ConnectableView.h"
 
 //! Class representing view of Particle item
 class BA_CORE_API_ ParticleCoreShellView : public ConnectableView
diff --git a/GUI/coregui/Views/SampleDesigner/ParticleDistributionView.h b/GUI/coregui/Views/SampleDesigner/ParticleDistributionView.h
index df8b2a22f5fcaa1fb28ffc39587ec7f2937d5b20..7aa509f514aa45bcdb7b9d1d98da8a6da691a502 100644
--- a/GUI/coregui/Views/SampleDesigner/ParticleDistributionView.h
+++ b/GUI/coregui/Views/SampleDesigner/ParticleDistributionView.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/SampleDesigner/ParticleDistributionView.h
-//! @brief     Declares class ParticleDistributionView
+//! @brief     Defines class ParticleDistributionView
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef PARTICLEDISTRIBUTIONVIEW_H
 #define PARTICLEDISTRIBUTIONVIEW_H
 
-#include "ConnectableView.h" // inheriting from
+#include "ConnectableView.h"
 
 //! Class representing view of distributed particle item
 class BA_CORE_API_ ParticleDistributionView : public ConnectableView
diff --git a/GUI/coregui/Views/SampleDesigner/ParticleLayoutView.h b/GUI/coregui/Views/SampleDesigner/ParticleLayoutView.h
index aa42e9caa7cf4f1c3108b7504310da70007f65fa..3397887ae0be5465bb656cfc830af6775fb4c279 100644
--- a/GUI/coregui/Views/SampleDesigner/ParticleLayoutView.h
+++ b/GUI/coregui/Views/SampleDesigner/ParticleLayoutView.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/SampleDesigner/ParticleLayoutView.h
-//! @brief     Declares class ParticleLayoutView
+//! @brief     Defines class ParticleLayoutView
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef PARTICLELAYOUTVIEW_H
 #define PARTICLELAYOUTVIEW_H
 
-#include "ConnectableView.h" // inheriting from
+#include "ConnectableView.h"
 
 class BA_CORE_API_ ParticleLayoutView : public ConnectableView
 {
diff --git a/GUI/coregui/Views/SampleDesigner/ParticleView.h b/GUI/coregui/Views/SampleDesigner/ParticleView.h
index 730b3ca65911e8dde0f8ab59bc6ac3536e14a1da..2c94bf7bc43ab905f9b192d65ed19dfbbc4bcc4f 100644
--- a/GUI/coregui/Views/SampleDesigner/ParticleView.h
+++ b/GUI/coregui/Views/SampleDesigner/ParticleView.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/SampleDesigner/ParticleView.h
-//! @brief     Declares class ParticleView
+//! @brief     Defines class ParticleView
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef PARTICLEVIEW_H
 #define PARTICLEVIEW_H
 
-#include "ConnectableView.h" // inheriting from
+#include "ConnectableView.h"
 #include <QPixmap>
 
 //! Class representing view of Particle item
diff --git a/GUI/coregui/Views/SampleDesigner/SampleDesigner.h b/GUI/coregui/Views/SampleDesigner/SampleDesigner.h
index f40fd7c8603d0f9f33a45f7a7d4fdab3461359c2..df936a6456b8c1bb106e4d60ab224bd17d1cfa15 100644
--- a/GUI/coregui/Views/SampleDesigner/SampleDesigner.h
+++ b/GUI/coregui/Views/SampleDesigner/SampleDesigner.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/SampleDesigner/SampleDesigner.h
-//! @brief     Declares class SampleDesigner
+//! @brief     Defines class SampleDesigner
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/SampleDesigner/SamplePropertyWidget.h b/GUI/coregui/Views/SampleDesigner/SamplePropertyWidget.h
index 036c51ef51d57326b2b8f7ae9f68ec0aba5f1bd8..73255c1ff0bf1ae0afb7de6b9ab6390efc6fd323 100644
--- a/GUI/coregui/Views/SampleDesigner/SamplePropertyWidget.h
+++ b/GUI/coregui/Views/SampleDesigner/SamplePropertyWidget.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/SampleDesigner/SamplePropertyWidget.h
-//! @brief     Declares class SamplePropertyWidget
+//! @brief     Defines class SamplePropertyWidget
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/SampleDesigner/SampleToolBar.h b/GUI/coregui/Views/SampleDesigner/SampleToolBar.h
index 6da80ca1415741478ac28ebb47dc6dc52d81ad2e..923fefe42944add09f49622a6b81d2b090d4afda 100644
--- a/GUI/coregui/Views/SampleDesigner/SampleToolBar.h
+++ b/GUI/coregui/Views/SampleDesigner/SampleToolBar.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/SampleDesigner/SampleToolBar.h
-//! @brief     Declares class SampleToolBar
+//! @brief     Defines class SampleToolBar
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef SAMPLETOOLBAR_H
 #define SAMPLETOOLBAR_H
 
-#include "StyledToolBar.h" // inheriting from
+#include "StyledToolBar.h"
 
 class QAction;
 class QToolButton;
diff --git a/GUI/coregui/Views/SampleDesigner/SampleViewAligner.h b/GUI/coregui/Views/SampleDesigner/SampleViewAligner.h
index 101bda50427c3ec254edab0c45a402b6702338a3..626ef15cf08bff6c10cefd06c26b44d5a92a2995 100644
--- a/GUI/coregui/Views/SampleDesigner/SampleViewAligner.h
+++ b/GUI/coregui/Views/SampleDesigner/SampleViewAligner.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/SampleDesigner/SampleViewAligner.h
-//! @brief     Declares class SampleViewAligner
+//! @brief     Defines class SampleViewAligner
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/SampleDesigner/SampleViewFactory.h b/GUI/coregui/Views/SampleDesigner/SampleViewFactory.h
index 49d55bac96e3f1d45c8adf31b5d5f6921ce2bba7..eeaf76d9799dff54d4c904e4658ecc7ebdbf6419 100644
--- a/GUI/coregui/Views/SampleDesigner/SampleViewFactory.h
+++ b/GUI/coregui/Views/SampleDesigner/SampleViewFactory.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/SampleDesigner/SampleViewFactory.h
-//! @brief     Declares class SampleViewFactory
+//! @brief     Defines class SampleViewFactory
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/SampleDesigner/SampleWidgetBox.h b/GUI/coregui/Views/SampleDesigner/SampleWidgetBox.h
index b6131b223cd11551c972ed9bc34f616f5d38f7f3..402de2e84be1e1a6459633f84a9442292de3f7dd 100644
--- a/GUI/coregui/Views/SampleDesigner/SampleWidgetBox.h
+++ b/GUI/coregui/Views/SampleDesigner/SampleWidgetBox.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/SampleDesigner/SampleWidgetBox.h
-//! @brief     Declares class SampleWidgetBox
+//! @brief     Defines class SampleWidgetBox
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/SampleDesigner/TransformationView.h b/GUI/coregui/Views/SampleDesigner/TransformationView.h
index 9b75dec4fabda79bcc4564080617c264b8dadd9a..e7da515822fe817bfd832c69824100ae6f20df3b 100644
--- a/GUI/coregui/Views/SampleDesigner/TransformationView.h
+++ b/GUI/coregui/Views/SampleDesigner/TransformationView.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/SampleDesigner/TransformationView.h
-//! @brief     Declares class TransformationView
+//! @brief     Defines class TransformationView
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -18,7 +18,7 @@
 #define TRANSFORMATIONVIEW_H
 
 
-#include "ConnectableView.h" // inheriting from
+#include "ConnectableView.h"
 
 class TransformationView : public ConnectableView
 {
diff --git a/GUI/coregui/Views/SampleView.h b/GUI/coregui/Views/SampleView.h
index 2d6a0cdb902720f33becce7ceaed658ceda98ebe..d46590e38064909338a85cf84a22148793b69339 100644
--- a/GUI/coregui/Views/SampleView.h
+++ b/GUI/coregui/Views/SampleView.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/SampleView.h
-//! @brief     Declares class SampleView
+//! @brief     Defines class SampleView
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/SampleViewComponents.h b/GUI/coregui/Views/SampleViewComponents.h
index c562102df049cf89cdf552fd0893e2dd0c31af14..8e2a8e551a25502186a87b7bda44c927b4e59bdc 100644
--- a/GUI/coregui/Views/SampleViewComponents.h
+++ b/GUI/coregui/Views/SampleViewComponents.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/SampleViewComponents.h
-//! @brief     Declares class SampleViewComponents
+//! @brief     Defines class SampleViewComponents
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/SessionModelView.h b/GUI/coregui/Views/SessionModelView.h
index c8632a37a8a0debba1216b02b8361e058d860d63..7c1dc17eade1c9603fe99634f9eabb3bf8b05d3e 100644
--- a/GUI/coregui/Views/SessionModelView.h
+++ b/GUI/coregui/Views/SessionModelView.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/SessionModelView.h
-//! @brief     Declares class SessionModelView
+//! @brief     Defines class SessionModelView
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/SimulationView.h b/GUI/coregui/Views/SimulationView.h
index 3abcf1ba99e56a45aaf8c1a80633a1b8dca983aa..d1988c29b36fbbb9603d4181d378e2fd58258426 100644
--- a/GUI/coregui/Views/SimulationView.h
+++ b/GUI/coregui/Views/SimulationView.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/SimulationView.h
-//! @brief     Declares class SimulationView
+//! @brief     Defines class SimulationView
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/SimulationWidgets/PythonScriptWidget.h b/GUI/coregui/Views/SimulationWidgets/PythonScriptWidget.h
index 88e5bb48d97043e515f64aa2b0e39fa16020f665..1aeb94460adafc3bd7111e959925038a16176257 100644
--- a/GUI/coregui/Views/SimulationWidgets/PythonScriptWidget.h
+++ b/GUI/coregui/Views/SimulationWidgets/PythonScriptWidget.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/SimulationWidgets/PythonScriptWidget.h
-//! @brief     Declares class PythonScriptWidget
+//! @brief     Defines class PythonScriptWidget
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/SimulationWidgets/SimulationDataSelectorWidget.h b/GUI/coregui/Views/SimulationWidgets/SimulationDataSelectorWidget.h
index e4bb1d5cc2bc6039e69e13812143f5bc5fe2927e..faaf19678c59a5543af705c7714fe72f1a66e9f6 100644
--- a/GUI/coregui/Views/SimulationWidgets/SimulationDataSelectorWidget.h
+++ b/GUI/coregui/Views/SimulationWidgets/SimulationDataSelectorWidget.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/SimulationWidgets/SimulationDataSelectorWidget.h
-//! @brief     Declares class SimulationDataSelectorWidget
+//! @brief     Defines class SimulationDataSelectorWidget
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/SimulationWidgets/SimulationOptionsWidget.h b/GUI/coregui/Views/SimulationWidgets/SimulationOptionsWidget.h
index bbac91eb814dbadaccc5af9fcc19849c3e14aa47..ae22da3d9ab11594580687576fc4388e43e223d4 100644
--- a/GUI/coregui/Views/SimulationWidgets/SimulationOptionsWidget.h
+++ b/GUI/coregui/Views/SimulationWidgets/SimulationOptionsWidget.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/SimulationWidgets/SimulationOptionsWidget.h
-//! @brief     Declares class SimulationOptionsWidget
+//! @brief     Defines class SimulationOptionsWidget
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/SimulationWidgets/SimulationSetupAssistant.h b/GUI/coregui/Views/SimulationWidgets/SimulationSetupAssistant.h
index 032eb1ed8ac9583c74172d75251915ba65957164..f52f08c63041ab6eaba771f6aca03cdbb8fa877e 100644
--- a/GUI/coregui/Views/SimulationWidgets/SimulationSetupAssistant.h
+++ b/GUI/coregui/Views/SimulationWidgets/SimulationSetupAssistant.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/SimulationWidgets/SimulationSetupAssistant.h
-//! @brief     Declares class SimulationSetupAssistant
+//! @brief     Defines class SimulationSetupAssistant
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/SimulationWidgets/SimulationSetupWidget.h b/GUI/coregui/Views/SimulationWidgets/SimulationSetupWidget.h
index 36b9feb6dcace0a63d74d8343c4dae5c33eba480..6870391cf632f8edfa44793b435f367933aa017e 100644
--- a/GUI/coregui/Views/SimulationWidgets/SimulationSetupWidget.h
+++ b/GUI/coregui/Views/SimulationWidgets/SimulationSetupWidget.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/SimulationWidgets/SimulationSetupWidget.h
-//! @brief     Declares class SimulationSetupWidget
+//! @brief     Defines class SimulationSetupWidget
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/TestComponentView.h b/GUI/coregui/Views/TestComponentView.h
index 62b43c45b2bdee6ad915f790537d07a8fb11cb88..e025e2dddb62851eac6c909607c7f0c641263abe 100644
--- a/GUI/coregui/Views/TestComponentView.h
+++ b/GUI/coregui/Views/TestComponentView.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/TestComponentView.h
-//! @brief     Declares class TestComponentView
+//! @brief     Defines class TestComponentView
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/TestView.h b/GUI/coregui/Views/TestView.h
index 637686807712a2133a9f73d733fd4a5fb6a510fc..4033ab5247b9c2459e0e2b15bdb65ba5d0a1eb82 100644
--- a/GUI/coregui/Views/TestView.h
+++ b/GUI/coregui/Views/TestView.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/TestView.h
-//! @brief     Declares class TestView
+//! @brief     Defines class TestView
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/Views/WelcomeView.h b/GUI/coregui/Views/WelcomeView.h
index b24474a3e49ee0b8baa56408c5d2f713b1a9903c..ca4c7dbd12707840835576c402611c32cf800af0 100644
--- a/GUI/coregui/Views/WelcomeView.h
+++ b/GUI/coregui/Views/WelcomeView.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/Views/WelcomeView.h
-//! @brief     Declares class WelcomeView
+//! @brief     Defines class WelcomeView
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/mainwindow/AppSvc.h b/GUI/coregui/mainwindow/AppSvc.h
index e4463bfd556936e2c940b9197c53dab161e3b0c9..2dcbf06eecf439d8a6f465ffce4002976ad86b66 100644
--- a/GUI/coregui/mainwindow/AppSvc.h
+++ b/GUI/coregui/mainwindow/AppSvc.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/mainwindow/AppSvc.h
-//! @brief     Declares class AppSvc
+//! @brief     Defines class AppSvc
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef APPSVC_H
 #define APPSVC_H
 
-#include "ISingleton.h" // inheriting from
+#include "ISingleton.h"
 #include "WinDllMacros.h"
 
 class ProjectManager;
diff --git a/GUI/coregui/mainwindow/SplashScreen.h b/GUI/coregui/mainwindow/SplashScreen.h
index ed697c60b73082ee23ecae244b25ebc46653e6f0..574104c0b144c37d72ba46a681fb5a5f661c804c 100644
--- a/GUI/coregui/mainwindow/SplashScreen.h
+++ b/GUI/coregui/mainwindow/SplashScreen.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/mainwindow/SplashScreen.h
-//! @brief     Declares class SplashScreen
+//! @brief     Defines class SplashScreen
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/mainwindow/StyledToolBar.h b/GUI/coregui/mainwindow/StyledToolBar.h
index b2df4a0de9b5f1c3e619aaead9421ade4bf56507..852b9949d119e2dcbc38bac9f159795c8e3d351d 100644
--- a/GUI/coregui/mainwindow/StyledToolBar.h
+++ b/GUI/coregui/mainwindow/StyledToolBar.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/mainwindow/StyledToolBar.h
-//! @brief     Declares class StyledToolBar
+//! @brief     Defines class StyledToolBar
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/mainwindow/aboutapplicationdialog.h b/GUI/coregui/mainwindow/aboutapplicationdialog.h
index 97603d80707ce9b85af48199cf030527244c7bc4..5a11b6050315025d04dd0c68620fb4f7a98d3b36 100644
--- a/GUI/coregui/mainwindow/aboutapplicationdialog.h
+++ b/GUI/coregui/mainwindow/aboutapplicationdialog.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/mainwindow/aboutapplicationdialog.h
-//! @brief     Declares class AboutApplicationDialog
+//! @brief     Defines class AboutApplicationDialog
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/mainwindow/actionmanager.h b/GUI/coregui/mainwindow/actionmanager.h
index 26364ce1924d5a042c5075876b659f462ca1fff3..c2500068cd6029341879f7b3a1dbcf9c98672929 100644
--- a/GUI/coregui/mainwindow/actionmanager.h
+++ b/GUI/coregui/mainwindow/actionmanager.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/mainwindow/actionmanager.h
-//! @brief     Declares class ActionManager
+//! @brief     Defines class ActionManager
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/mainwindow/mainwindow.h b/GUI/coregui/mainwindow/mainwindow.h
index 3827baa10a2ef37c0fe732d2cb5a897b35c62199..75d0fe9918702cb311983ea871edfb4bae6b4bf6 100644
--- a/GUI/coregui/mainwindow/mainwindow.h
+++ b/GUI/coregui/mainwindow/mainwindow.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/mainwindow/mainwindow.h
-//! @brief     Declares class MainWindow
+//! @brief     Defines class MainWindow
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/mainwindow/mainwindow_constants.h b/GUI/coregui/mainwindow/mainwindow_constants.h
index 2b3cb2407b7e9ee1d9a59a31ea421ec44896c2a8..da14e30cbe5e306b651bc34b81a4cbf28ea9f802 100644
--- a/GUI/coregui/mainwindow/mainwindow_constants.h
+++ b/GUI/coregui/mainwindow/mainwindow_constants.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/mainwindow/mainwindow_constants.h
-//! @brief     Declares namespace Constants
+//! @brief     Defines namespace Constants
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/mainwindow/newprojectdialog.h b/GUI/coregui/mainwindow/newprojectdialog.h
index 875edf4977297d8ecda6083083ee43b071a6fc13..2e8d4c949635bc813ff97327b464f20d9cf4cb19 100644
--- a/GUI/coregui/mainwindow/newprojectdialog.h
+++ b/GUI/coregui/mainwindow/newprojectdialog.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/mainwindow/newprojectdialog.h
-//! @brief     Declares class NewProjectDialog
+//! @brief     Defines class NewProjectDialog
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/mainwindow/projectdocument.h b/GUI/coregui/mainwindow/projectdocument.h
index 988d0146e5bd972a4242796b329af0efef870b2d..f6c850d428ed65026efb7d9c4a310aaff05d9159 100644
--- a/GUI/coregui/mainwindow/projectdocument.h
+++ b/GUI/coregui/mainwindow/projectdocument.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/mainwindow/projectdocument.h
-//! @brief     Declares class ProjectDocument
+//! @brief     Defines class ProjectDocument
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/mainwindow/projectmanager.h b/GUI/coregui/mainwindow/projectmanager.h
index 1ec16bf82949b896199ed24a412494b8927f933e..182ef2d9e7450d50747d8778933080f369e59ae1 100644
--- a/GUI/coregui/mainwindow/projectmanager.h
+++ b/GUI/coregui/mainwindow/projectmanager.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/mainwindow/projectmanager.h
-//! @brief     Declares class ProjectManager
+//! @brief     Defines class ProjectManager
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/mainwindow/tooltipdatabase.h b/GUI/coregui/mainwindow/tooltipdatabase.h
index a5a27d59e84adbfe7bbbb45e84a5861d2982e3b0..a0a38438b78bf365973d25c733fbbc88fc63658a 100644
--- a/GUI/coregui/mainwindow/tooltipdatabase.h
+++ b/GUI/coregui/mainwindow/tooltipdatabase.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/mainwindow/tooltipdatabase.h
-//! @brief     Declares class ToolTipDataBase
+//! @brief     Defines class ToolTipDataBase
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/utils/CustomEventFilters.h b/GUI/coregui/utils/CustomEventFilters.h
index 0f8d396fa871f8c73b38f85771b27f9f46862a4c..63ef9d010af7d1af871d936e4a479de54d20d479 100644
--- a/GUI/coregui/utils/CustomEventFilters.h
+++ b/GUI/coregui/utils/CustomEventFilters.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/utils/CustomEventFilters.h
-//! @brief     Declares classes releted to event filtering
+//! @brief     Defines classes releted to event filtering
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/utils/FancyLabel.h b/GUI/coregui/utils/FancyLabel.h
index 1d7a0d8d71d3a5dc5b42a9436fcaaa12fe609a44..eae59fd3d6a60880ff306a5dc5284036dbe6ca8f 100644
--- a/GUI/coregui/utils/FancyLabel.h
+++ b/GUI/coregui/utils/FancyLabel.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/utils/FancyLabel.h
-//! @brief     Declares class FancyLabel
+//! @brief     Defines class FancyLabel
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/utils/GUIHelpers.h b/GUI/coregui/utils/GUIHelpers.h
index 9c6a85f1212f6e1ad6ae60668adeee88cf651359..56b720160aeaf1d0153b90ef4bb79f2e9ea930d3 100644
--- a/GUI/coregui/utils/GUIHelpers.h
+++ b/GUI/coregui/utils/GUIHelpers.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/utils/GUIHelpers.h
-//! @brief     Declares class GUIHelpers functions
+//! @brief     Defines class GUIHelpers functions
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/utils/GUIMessage.h b/GUI/coregui/utils/GUIMessage.h
index 714f9854fec2d2c7e15265c4d978d25ca143c5c2..7c09dd9db56bba0a8b599116577c9446ee514ade 100644
--- a/GUI/coregui/utils/GUIMessage.h
+++ b/GUI/coregui/utils/GUIMessage.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/utils/GUIMessage.h
-//! @brief     Declares class GUIMessage.
+//! @brief     Defines class GUIMessage.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/utils/IMessageService.h b/GUI/coregui/utils/IMessageService.h
index e1fffaba4c3c8c89f282e911c5f726b12867e48a..1a3df6bba7cd2afeeb3e728bf60bd3e9f794cf00 100644
--- a/GUI/coregui/utils/IMessageService.h
+++ b/GUI/coregui/utils/IMessageService.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/utils/IMessageService.h
-//! @brief     Declares abstract IMessageService interface
+//! @brief     Defines abstract IMessageService interface
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/utils/ItemIDFactory.h b/GUI/coregui/utils/ItemIDFactory.h
index a052d53ff38dd5f20a30167021549ec0d5148227..cecd98eabc50bd8e9d3d43c82cc4101f7149aab0 100644
--- a/GUI/coregui/utils/ItemIDFactory.h
+++ b/GUI/coregui/utils/ItemIDFactory.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/utils/ItemIDFactory.h
-//! @brief     Declares class ItemIDFactory
+//! @brief     Defines class ItemIDFactory
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/utils/MessageContainer.h b/GUI/coregui/utils/MessageContainer.h
index b609c7b39c5237dbc83f4dfed3cd8d9f548d44a4..822035b002812d580a195c5908d2850cd364d906 100644
--- a/GUI/coregui/utils/MessageContainer.h
+++ b/GUI/coregui/utils/MessageContainer.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/utils/MessageContainer.h
-//! @brief     Declares class MessageContainer.
+//! @brief     Defines class MessageContainer.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/utils/WarningMessageService.h b/GUI/coregui/utils/WarningMessageService.h
index 1e57dea6c895be6b474433502f8bc33151c08841..92f4cda30098ddd681fa2954fe57ed3855f51682 100644
--- a/GUI/coregui/utils/WarningMessageService.h
+++ b/GUI/coregui/utils/WarningMessageService.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/utils/WarningMessageService.h
-//! @brief     Declares abstract IMessageService interface
+//! @brief     Defines abstract IMessageService interface
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef WARNINGMESSAGESERVICE_H
 #define WARNINGMESSAGESERVICE_H
 
-#include "IMessageService.h" // inheriting from
+#include "IMessageService.h"
 #include <QMap>
 #include <QStringList> // need detected by TeamCity
 
diff --git a/GUI/coregui/utils/hostosinfo.h b/GUI/coregui/utils/hostosinfo.h
index 5c52033fe302e203f10af174b76dfdaa71e32971..49b99815ff8f2b9d8072a19a10d3e63d3e4acfdd 100644
--- a/GUI/coregui/utils/hostosinfo.h
+++ b/GUI/coregui/utils/hostosinfo.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/utils/hostosinfo.h
-//! @brief     Declares Utils namespace
+//! @brief     Defines Utils namespace
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/GUI/coregui/utils/qstringutils.h b/GUI/coregui/utils/qstringutils.h
index 193860c520ac30fd1fef2e2c82a61bb422f239b2..92c307dda16204d6db0742eee5f07ac270d63909 100644
--- a/GUI/coregui/utils/qstringutils.h
+++ b/GUI/coregui/utils/qstringutils.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      GUI/coregui/utils/qstringutils.h
-//! @brief     Declares functions from Utils namespace
+//! @brief     Defines functions from Utils namespace
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Tests/Functional/Core/CoreTest.h b/Tests/Functional/Core/CoreTest.h
index 68d9ace09cfe6e928f1f07b10fcba928a48250fc..6bb82a6f61b21a34194ebe8c1936ccdc5987bd27 100644
--- a/Tests/Functional/Core/CoreTest.h
+++ b/Tests/Functional/Core/CoreTest.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Tests/Functional/Core/CoreTest.h
-//! @brief     Declares class CoreTest.
+//! @brief     Defines class CoreTest.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef CORETEST_H
 #define CORETEST_H
 
-#include "IReferencedTest.h" // inheriting from
+#include "IReferencedTest.h"
 
 template <class T> class OutputData;
 class GISASSimulation;
diff --git a/Tests/Functional/Fit/IMinimizerTest.cpp b/Tests/Functional/Fit/IMinimizerTest.cpp
index 27622929ee2573c82503d1794e6f9e2a80539004..f792ee3dd29042996e01b89ece1c8e2bb138678e 100644
--- a/Tests/Functional/Fit/IMinimizerTest.cpp
+++ b/Tests/Functional/Fit/IMinimizerTest.cpp
@@ -49,9 +49,8 @@ IMinimizerTest::IMinimizerTest(const std::string& minimizer_name,
 void IMinimizerTest::runTest()
 {
     std::unique_ptr<ISample> sample(createSample());
-    for (size_t i = 0; i < m_parameters.size(); ++i) {
+    for (size_t i = 0; i < m_parameters.size(); ++i)
         sample->setParameterValue(m_parameters[i].m_name, m_parameters[i].m_real_value);
-    }
 
     std::unique_ptr<GISASSimulation> simulation(createSimulation());
     simulation->setSample(*sample.get());
@@ -65,9 +64,8 @@ void IMinimizerTest::runTest()
     // run fit
     fitSuite->runFit();
 
-    for (size_t i = 0; i < m_parameters.size(); ++i) {
+    for (size_t i = 0; i < m_parameters.size(); ++i)
         m_parameters[i].m_found_value = fitSuite->getMinimizer()->getValueOfVariableAtMinimum(i);
-    }
 
     // analyze results
     for (size_t i = 0; i < m_parameters.size(); ++i) {
diff --git a/Tests/Functional/Fit/IMinimizerTest.h b/Tests/Functional/Fit/IMinimizerTest.h
index ee840d5ddf8a88327fc215ef2862995b1f1d2795..49377d2bdb40b1f99c89fd9ec9e3f605f8f2bb4e 100644
--- a/Tests/Functional/Fit/IMinimizerTest.h
+++ b/Tests/Functional/Fit/IMinimizerTest.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Tests/Functional/Fit/IMinimizerTest.h
-//! @brief     Declares class IMinimizerTest.
+//! @brief     Defines class IMinimizerTest.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef IMINIMIZERTEST_H
 #define IMINIMIZERTEST_H
 
-#include "IFunctionalTest.h" // inheriting from
+#include "IFunctionalTest.h"
 #include "OutputData.h"
 #include <memory>
 
diff --git a/Tests/Functional/Fit/MinimizerTests.h b/Tests/Functional/Fit/MinimizerTests.h
index c899fc6b0ee88b216d621100501be18bfb5ce482..15e9bbc89e71bc1ddddc8048c74399bbfeb3789b 100644
--- a/Tests/Functional/Fit/MinimizerTests.h
+++ b/Tests/Functional/Fit/MinimizerTests.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Tests/Functional/Fit/MinimizerTests.h
-//! @brief     Declares classes MinimizerTests.
+//! @brief     Defines classes MinimizerTests.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef MINIMIZERTESTS_H
 #define MINIMIZERTESTS_H
 
-#include "IMinimizerTest.h" // inheriting from
+#include "IMinimizerTest.h"
 
 //! basic test of Minuit2/Migrad minimizer
 class Minuit2MigradTest : public IMinimizerTest
diff --git a/Tests/Functional/Fit/RectDetectorFitTest.h b/Tests/Functional/Fit/RectDetectorFitTest.h
index 618ac8f6b2b60a8cbea0809a13467821955927e3..9ea4d8aabc8d7e8e14a42378e96e7889452f21d4 100644
--- a/Tests/Functional/Fit/RectDetectorFitTest.h
+++ b/Tests/Functional/Fit/RectDetectorFitTest.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Tests/Functional/Fit/RectDetectorFitTest.h
-//! @brief     Declares class RectDetectorFitTest.
+//! @brief     Defines class RectDetectorFitTest.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef RECTDETECTORFITTEST_H
 #define RECTDETECTORFITTEST_H
 
-#include "IMinimizerTest.h" // inheriting from
+#include "IMinimizerTest.h"
 
 
 //! @class RectDetectorFitTest
diff --git a/Tests/Functional/Fit/StandardFitsFactory.h b/Tests/Functional/Fit/StandardFitsFactory.h
index cbedb563f07b67cb183bb710224941aeb960e962..aba6dde2d3eb297eda322f1dee6061ffb66cb96d 100644
--- a/Tests/Functional/Fit/StandardFitsFactory.h
+++ b/Tests/Functional/Fit/StandardFitsFactory.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Tests/Functional/Fit/StandardFitsFactory.h
-//! @brief     Declares class StandardFitsFactory
+//! @brief     Defines class StandardFitsFactory
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef STANDARDFITSFACTORY_H
 #define STANDARDFITSFACTORY_H
 
-#include "IFactory.h" // inheriting from
+#include "IFactory.h"
 
 class IFunctionalTest;
 
diff --git a/Tests/Functional/GUI/GUITest.h b/Tests/Functional/GUI/GUITest.h
index 81a1990efd71de3b4a877d005676cb98949852da..29806b4fdbc3b9c8356fdbdd42433285eae2c700 100644
--- a/Tests/Functional/GUI/GUITest.h
+++ b/Tests/Functional/GUI/GUITest.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Tests/Functional/GUI/GUITest.h
-//! @brief     Declares class GUITest
+//! @brief     Defines class GUITest
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,7 +17,7 @@
 #ifndef GUITEST_H
 #define GUITEST_H
 
-#include "IReferencedTest.h" // inheriting from
+#include "IReferencedTest.h"
 #include "OutputData.h"
 
 class GISASSimulation;
diff --git a/Tests/Functional/PyCore/export/PyExportTest.h b/Tests/Functional/PyCore/export/PyExportTest.h
index 42ed47562ae7f69b6208990cca61b42c7c5948a6..e9ca848d89c133075f068c740db4f20913140b5d 100644
--- a/Tests/Functional/PyCore/export/PyExportTest.h
+++ b/Tests/Functional/PyCore/export/PyExportTest.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Tests/Functional/PyCore/export/PyExportTest.h
-//! @brief     Declares class PyExportTest
+//! @brief     Defines class PyExportTest
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef PYEXPORTTEST_H
 #define PYEXPORTTEST_H
 
-#include "IReferencedTest.h" // inheriting from
+#include "IReferencedTest.h"
 #include "OutputData.h"
 
 //! @class PyExportTest
diff --git a/Tests/Functional/PyCore/persistence/PyPersistenceTest.cpp b/Tests/Functional/PyCore/persistence/PyPersistenceTest.cpp
index 80eaf8ab58f0ed79d59b0483ad39d47340c46ba1..8d3b1a5e76f1b7f071e4fc9845882cd90bd89728 100644
--- a/Tests/Functional/PyCore/persistence/PyPersistenceTest.cpp
+++ b/Tests/Functional/PyCore/persistence/PyPersistenceTest.cpp
@@ -58,10 +58,11 @@ void PyPersistenceTest::runTest()
     // Glob simulation results
     std::map<const std::string, const std::string> dat;
     std::string dat_pattern = dat_stem + ".*.*";
-    for (const std::string& fname: FileSystem::glob(dat_pattern))
-        dat.insert(make_pair(Utils::String::split(fname,".")[1]+"."+
-                             Utils::String::split(fname,".")[2],
-                             fname));
+    for (const std::string& fpath: FileSystem::glob(dat_pattern)) {
+        std::vector<std::string> fname_segments =
+            Utils::String::split(FileSystem::filename(fpath), ".");
+        dat.insert(make_pair(fname_segments[1]+"."+fname_segments[2], fpath));
+    }
     if (dat.size()==0) {
         std::cerr << "There is no test output of form " << dat_pattern << "\n";
         m_result = FAILED;
@@ -71,11 +72,11 @@ void PyPersistenceTest::runTest()
     // Glob reference files
     std::string ref_stem = FileSystem::GetJoinPath(PYPERSIST_REF_DIR, getName());
     std::map<const std::string, const std::string> ref;
-    for (const std::string& fname: FileSystem::glob(ref_stem+".*.*"))
-        ref.insert(make_pair(Utils::String::split(fname,".")[1]+"."+
-                             Utils::String::split(fname,".")[2],
-                             fname));
-
+    for (const std::string& fpath: FileSystem::glob(ref_stem+".*.*")) {
+        std::vector<std::string> fname_segments =
+            Utils::String::split(FileSystem::filename(fpath), ".");
+        ref.insert(make_pair(fname_segments[1]+"."+fname_segments[2], fpath));
+    }
     // Compare file lists
     m_result = SUCCESS;
     for( auto const& it: dat ) {
diff --git a/Tests/Functional/PyCore/persistence/PyPersistenceTest.h b/Tests/Functional/PyCore/persistence/PyPersistenceTest.h
index cf433ee6a280ed6dd31f5a2503e3734688062b39..3de5048452b9c955f5ef7218a2d2e5a2daa0ceb8 100644
--- a/Tests/Functional/PyCore/persistence/PyPersistenceTest.h
+++ b/Tests/Functional/PyCore/persistence/PyPersistenceTest.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Tests/Functional/PyCore/persistence/PyPersistenceTest.h
-//! @brief     Declares class PyPersistenceTest
+//! @brief     Defines class PyPersistenceTest
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef PYPERSISTENCETEST_H
 #define PYPERSISTENCETEST_H
 
-#include "IReferencedTest.h" // inheriting from
+#include "IReferencedTest.h"
 #include "OutputData.h"
 
 //! @class PyPersistenceTest
diff --git a/Tests/Functional/TestMachinery/IFunctionalTest.h b/Tests/Functional/TestMachinery/IFunctionalTest.h
index 4460da8b364bde5b24eb5f234a4fd783536832e2..9f172181eadc6d5894b241f6bccf8a547ac84ce4 100644
--- a/Tests/Functional/TestMachinery/IFunctionalTest.h
+++ b/Tests/Functional/TestMachinery/IFunctionalTest.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Tests/Functional/TestMachinery/IFunctionalTest.h
-//! @brief     Declares pure virtual base class IFunctionalTest.
+//! @brief     Defines pure virtual base class IFunctionalTest.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef IFUNCTIONALTEST_H
 #define IFUNCTIONALTEST_H
 
-#include "INamed.h" // inheriting from
+#include "INamed.h"
 #include <map>
 
 //! @class IFunctionalTest
diff --git a/Tests/Functional/TestMachinery/IReferencedTest.h b/Tests/Functional/TestMachinery/IReferencedTest.h
index 5d23541d644c3bc1d2a32c6aa1af18e60b338554..56263f95eff307db6c3dceea8b8abf71c370e859 100644
--- a/Tests/Functional/TestMachinery/IReferencedTest.h
+++ b/Tests/Functional/TestMachinery/IReferencedTest.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Tests/Functional/TestMachinery/IReferencedTest.h
-//! @brief     Declares pure virtual base class IReferencedTest.
+//! @brief     Defines pure virtual base class IReferencedTest.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef IREFERENCEDTEST_H
 #define IREFERENCEDTEST_H
 
-#include "IFunctionalTest.h" // inheriting from
+#include "IFunctionalTest.h"
 #include "OutputData.h"
 #include <map>
 
diff --git a/Tests/Functional/TestMachinery/IRegistry.h b/Tests/Functional/TestMachinery/IRegistry.h
index 71e395e6e2a92909cc3ecd6fa244127557b745cc..8cf14b1c6e6c268970a3d23397b31699d4001715 100644
--- a/Tests/Functional/TestMachinery/IRegistry.h
+++ b/Tests/Functional/TestMachinery/IRegistry.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Tests/Functional/TestMachinery/IRegistry.h
-//! @brief     Declares templated registry for ICloneable objects
+//! @brief     Defines templated registry for ICloneable objects
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Tests/Functional/TestMachinery/IStandardTest.h b/Tests/Functional/TestMachinery/IStandardTest.h
index 16fb1949a825585f63696e88a354a5d9455c2425..0b911b04d6c2e7b5d0184fdaa05cfef86a0ecdc2 100644
--- a/Tests/Functional/TestMachinery/IStandardTest.h
+++ b/Tests/Functional/TestMachinery/IStandardTest.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Tests/Functional/TestMachinery/IStandardTest.h
-//! @brief     Declares class IStandardTest.
+//! @brief     Defines class IStandardTest.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef ISTANDARDTEST_H
 #define ISTANDARDTEST_H
 
-#include "INamed.h" // inheriting from
+#include "INamed.h"
 
 class GISASSimulation;
 class IFunctionalTest;
diff --git a/Tests/Functional/TestMachinery/SimulationInfo.h b/Tests/Functional/TestMachinery/SimulationInfo.h
index 9433c0c557800a7478809f1f70379f7beb4141d1..c4358ede602a941bcb1e83faec31186db068c11b 100644
--- a/Tests/Functional/TestMachinery/SimulationInfo.h
+++ b/Tests/Functional/TestMachinery/SimulationInfo.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Tests/Functional/TestMachinery/SimulationInfo.h
-//! @brief     Declares class SimulationInfo.
+//! @brief     Defines class SimulationInfo.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Tests/Functional/TestMachinery/StandardSimulationsRegistry.h b/Tests/Functional/TestMachinery/StandardSimulationsRegistry.h
index 3f4f3e4f067eed872be4ab2aa74916a87e645712..e1243175f7f404baad20420b2a60e7a15d138bae 100644
--- a/Tests/Functional/TestMachinery/StandardSimulationsRegistry.h
+++ b/Tests/Functional/TestMachinery/StandardSimulationsRegistry.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Tests/Functional/TestMachinery/StandardSimulationsRegistry.h
-//! @brief     Declares class StandardSimulationsRegistry.
+//! @brief     Defines class StandardSimulationsRegistry.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef STANDARDSIMULATIONSREGISTRY_H
 #define STANDARDSIMULATIONSREGISTRY_H
 
-#include "ISingleton.h" // inheriting from
+#include "ISingleton.h"
 #include "SimulationInfo.h"
 #include <map>
 
diff --git a/Tests/Functional/TestMachinery/SubtestRegistry.h b/Tests/Functional/TestMachinery/SubtestRegistry.h
index ba88a6d890468d73994c6bd03db980c52da88167..159bb4e96b266edbbadc5108dbfd9399ee318280 100644
--- a/Tests/Functional/TestMachinery/SubtestRegistry.h
+++ b/Tests/Functional/TestMachinery/SubtestRegistry.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Tests/Functional/TestMachinery/SubtestRegistry.h
-//! @brief     Declares different registries for subtests of functional tests.
+//! @brief     Defines different registries for subtests of functional tests.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef SUBTESTREGISTRY_H
 #define SUBTESTREGISTRY_H
 
-#include "IRegistry.h" // inheriting from
+#include "IRegistry.h"
 #include "FTDistributions2D.h"
 
 class ISubtestRegistry : public IRegistry<IParameterized>
diff --git a/Tests/UnitTests/Core/0/CustomBinAxisTest.h b/Tests/UnitTests/Core/0/CustomBinAxisTest.h
index 7b4a85444655d980d550c55492a784572cceaf90..840b118ba4add9d5f03eed749985a8e8202db3ac 100644
--- a/Tests/UnitTests/Core/0/CustomBinAxisTest.h
+++ b/Tests/UnitTests/Core/0/CustomBinAxisTest.h
@@ -3,7 +3,7 @@
 
 #include "CustomBinAxis.h"
 #include "OutputDataIOHelper.h"
-#include "Units.h"
+#include "Pi.h"
 #include <vector>
 
 class CusomBinAxisTest: public ::testing::Test
diff --git a/Tests/UnitTests/Core/0/KVectorTest.h b/Tests/UnitTests/Core/0/KVectorTest.h
index f99ec25cee92671186a919264a45aeeb70627f95..ce268266a0c907b29d87c1712035988f7ee7478e 100644
--- a/Tests/UnitTests/Core/0/KVectorTest.h
+++ b/Tests/UnitTests/Core/0/KVectorTest.h
@@ -109,14 +109,14 @@ TEST_F(KVectorTest, BasicTransformation)
 
     // rotation via transformation
     a = kvector_t(std::sqrt(3.)/2., 2., 0.5);
-    Geometry::Transform3D m2 = Geometry::Transform3D::createRotateY(Units::PI/6.);
+    Geometry::Transform3D m2 = Geometry::Transform3D::createRotateY(Pi::PI/6.);
     v = m2.transformed(a);
     ASSERT_NEAR(      v.x(), 1.0, epsilon );
     EXPECT_DOUBLE_EQ( v.y(), 2.0 );
     ASSERT_NEAR(      v.z(), 0.0, epsilon );
 
     a = kvector_t(0.5, std::sqrt(3.)/2., 2.);
-    Geometry::Transform3D m3 = Geometry::Transform3D::createRotateZ(Units::PI/6.);
+    Geometry::Transform3D m3 = Geometry::Transform3D::createRotateZ(Pi::PI/6.);
     v = m3.transformed(a);
     ASSERT_NEAR(      v.x(), 0.0, epsilon );
     ASSERT_NEAR(      v.y(), 1.0, epsilon );
diff --git a/Tests/UnitTests/Core/1/FormFactorBasicTest.h b/Tests/UnitTests/Core/1/FormFactorBasicTest.h
index b30c5e4886d06e8246f3a684a83583e007950ab1..c7ecfc55392f9f66990b39dac75d2ec0960c02d6 100644
--- a/Tests/UnitTests/Core/1/FormFactorBasicTest.h
+++ b/Tests/UnitTests/Core/1/FormFactorBasicTest.h
@@ -13,7 +13,7 @@
 //
 // ************************************************************************** //
 
-#include "Units.h"
+#include "Pi.h"
 #include "BornAgainNamespace.h"
 #include "IFormFactorBorn.h"
 #include "HardParticles.h"
@@ -107,7 +107,7 @@ TEST_F(FormFactorBasicTest, HemiEllipsoid)
     double radius_b = 7.;
     double height = 5.;
 
-    double volume = 2.*Units::PI*radius_a*radius_b*height/3.;
+    double volume = 2.*Pi::PI*radius_a*radius_b*height/3.;
 
     FormFactorHemiEllipsoid hemiellipsoid(radius_a, radius_b, height);
 
@@ -145,7 +145,7 @@ TEST_F(FormFactorBasicTest, Cone)
     double alpha = 0.8;
     double tga = std::tan(alpha);
     double HdivRtga = height/tga/radius;
-    double volume = Units::PI/3.*tga*radius*radius*radius*
+    double volume = Pi::PI/3.*tga*radius*radius*radius*
             (1. - (1.- HdivRtga)*(1.- HdivRtga)*(1.- HdivRtga));
 
     FormFactorCone cone(radius, height, alpha);
@@ -210,7 +210,7 @@ TEST_F(FormFactorBasicTest, Cylinder)
 {
     double radius = 3.;
     double height = 5.;
-    double volume = Units::PI*radius*radius*height;
+    double volume = Pi::PI*radius*radius*height;
 
     FormFactorCylinder cylinder(radius,height);
 
@@ -240,7 +240,7 @@ TEST_F(FormFactorBasicTest, EllipsoidalCylinder)
     double radius_a = 3.;
     double radius_b = 5.;
     double height = 4;
-    double volume = Units::PI*radius_a*radius_b*height;
+    double volume = Pi::PI*radius_a*radius_b*height;
 
     FormFactorEllipsoidalCylinder ellipscyl(radius_a, radius_b, height);
 
@@ -256,7 +256,7 @@ TEST_F(FormFactorBasicTest, EllipsoidalCylinder)
 TEST_F(FormFactorBasicTest, FullSphere)
 {
     double radius = 5.;
-    double volume = 4./3.*Units::PI*radius*radius*radius;
+    double volume = 4./3.*Pi::PI*radius*radius*radius;
 
     FormFactorFullSphere fullsphere(radius);
     EXPECT_EQ(BornAgain::FFFullSphereType, fullsphere.getName());
@@ -270,7 +270,7 @@ TEST_F(FormFactorBasicTest, FullSpheroid)
 {
     double radius = 3.;
     double height = 5.;
-    double volume = 2./3.*Units::PI*radius*radius*height;
+    double volume = 2./3.*Pi::PI*radius*radius*height;
 
     FormFactorFullSpheroid fullspheroid(radius,height);
 
@@ -354,7 +354,7 @@ TEST_F(FormFactorBasicTest, TruncatedSphere)
     double radius = 5.;
     double height = 3.;
     double HdivR = height/radius;
-    double volume = Units::PI/3.*radius*radius*radius*
+    double volume = Pi::PI/3.*radius*radius*radius*
             (3.*HdivR -1. - (HdivR - 1.)*(HdivR - 1.)*(HdivR - 1.));
 
     FormFactorTruncatedSphere trsphere(radius, height);
@@ -371,7 +371,7 @@ TEST_F(FormFactorBasicTest, TruncatedSpheroid)
     double radius = 3.;
     double height = 5.;
     double flattening = 1.5;
-    double volume = Units::PI*radius*height*height/flattening*
+    double volume = Pi::PI*radius*height*height/flattening*
             (1.-height/(3.*flattening*radius));
 
     FormFactorTruncatedSpheroid trspheroid(radius, height, flattening);
diff --git a/Tests/UnitTests/Core/1/LayerTest.h b/Tests/UnitTests/Core/1/LayerTest.h
index f0feaf1e2442ba7decfec54a4e621904cb80fe64..f5e639ce490dbc115b2e660efa473e4b5f5f2fb5 100644
--- a/Tests/UnitTests/Core/1/LayerTest.h
+++ b/Tests/UnitTests/Core/1/LayerTest.h
@@ -4,8 +4,8 @@
 #include "Layer.h"
 #include "HomogeneousMaterial.h"
 #include "Materials.h"
-#include "Units.h"
 #include "ParticleLayout.h"
+#include "Units.h"
 
 class LayerTest : public ::testing::Test
 {
@@ -16,7 +16,6 @@ class LayerTest : public ::testing::Test
 };
 
 
-
 TEST_F(LayerTest, LayerInitialState)
 {
     Layer layer;
diff --git a/Tests/UnitTests/Core/1/MultiLayerTest.h b/Tests/UnitTests/Core/1/MultiLayerTest.h
index ad731795d9792d3898a37dc5141ef8663791de18..4ad90d700ac67cf8b5af32299e782d296659634a 100644
--- a/Tests/UnitTests/Core/1/MultiLayerTest.h
+++ b/Tests/UnitTests/Core/1/MultiLayerTest.h
@@ -6,7 +6,7 @@
 #include "Layer.h"
 #include "HomogeneousMaterial.h"
 #include "Materials.h"
-#include "Units.h"
+#include "Pi.h"
 #include "ParticleLayout.h"
 #include "Layer.h"
 #include "LayerInterface.h"
diff --git a/Tests/UnitTests/Core/1/ParticleCompositionTest.h b/Tests/UnitTests/Core/1/ParticleCompositionTest.h
index 81eef5969312b37b5d0ca8d959f5cb79bf3307e9..b81fbbbbf5575b8cbaf965ae661bcb7141c1fec0 100644
--- a/Tests/UnitTests/Core/1/ParticleCompositionTest.h
+++ b/Tests/UnitTests/Core/1/ParticleCompositionTest.h
@@ -4,7 +4,7 @@
 #include "ParticleComposition.h"
 #include "Particle.h"
 #include "Materials.h"
-#include "Units.h"
+#include "Pi.h"
 #include "HomogeneousMaterial.h"
 #include "FormFactorFullSphere.h"
 #include <iostream>
diff --git a/Tests/UnitTests/Core/1/ParticleCoreShellTest.h b/Tests/UnitTests/Core/1/ParticleCoreShellTest.h
index dc2081d1ed7a2121f8699dd2ec24660f78d3703b..6efe5f8a47e46ff3a9080fae48884dece49e6de9 100644
--- a/Tests/UnitTests/Core/1/ParticleCoreShellTest.h
+++ b/Tests/UnitTests/Core/1/ParticleCoreShellTest.h
@@ -4,7 +4,7 @@
 #include "HardParticles.h"
 #include "ParticleCoreShell.h"
 #include "BornAgainNamespace.h"
-#include "Units.h"
+#include "Pi.h"
 #include "HomogeneousMaterial.h"
 #include "Particle.h"
 #include "Rotations.h"
diff --git a/Tests/UnitTests/Core/1/ParticleTest.h b/Tests/UnitTests/Core/1/ParticleTest.h
index fdc23959a59d5834c43c813fa2a40579e660a02c..eff72f27a3da7e1ec3de4ac1a87a29a99784726e 100644
--- a/Tests/UnitTests/Core/1/ParticleTest.h
+++ b/Tests/UnitTests/Core/1/ParticleTest.h
@@ -3,7 +3,7 @@
 
 #include "Particle.h"
 #include "BornAgainNamespace.h"
-#include "Units.h"
+#include "Pi.h"
 #include "HomogeneousMaterial.h"
 #include "FormFactorFullSphere.h"
 
diff --git a/Tests/UnitTests/Core/2/MatrixSpecularInfoMapTest.h b/Tests/UnitTests/Core/2/MatrixSpecularInfoMapTest.h
index dd2fb941ec571f593e8a464caee0eb690cf2ec4e..a933556f8b27a06c4e0e747db8e45d2407566992 100644
--- a/Tests/UnitTests/Core/2/MatrixSpecularInfoMapTest.h
+++ b/Tests/UnitTests/Core/2/MatrixSpecularInfoMapTest.h
@@ -5,7 +5,7 @@
 #include "MatrixRTCoefficients.h"
 #include "MatrixSpecularInfoMap.h"
 #include "MultiLayer.h"
-#include "Units.h"
+#include "Pi.h"
 #include "Layer.h"
 #include <memory>
 
@@ -37,7 +37,7 @@ TEST_F(MatrixSpecularInfoMapTest, getCoefficients)
 {
     MatrixSpecularInfoMap map(mp_multilayer, 0);
     std::unique_ptr<const MatrixRTCoefficients> P_rt_coeffs(
-                map.getOutCoefficients(1.0, 1.0, 2.0*Units::PI));
+                map.getOutCoefficients(1.0, 1.0, 2.0*Pi::PI));
     complex_t R0 = complex_t(0.1750375, -0.0222467);
     complex_t lambda0 = complex_t(0.841471, 0.0);
     (void)R0;
diff --git a/Tests/UnitTests/Core/2/ScalarSpecularInfoMapTest.h b/Tests/UnitTests/Core/2/ScalarSpecularInfoMapTest.h
index f6add03f2b5eb9bd2014d23b46cd4a20ae969489..639dda200db9872db927bd4caedcf2b0635417dd 100644
--- a/Tests/UnitTests/Core/2/ScalarSpecularInfoMapTest.h
+++ b/Tests/UnitTests/Core/2/ScalarSpecularInfoMapTest.h
@@ -2,7 +2,7 @@
 #define SCALARSPECULARINFOMAPTEST_H
 
 #include "MultiLayer.h"
-#include "Units.h"
+#include "Pi.h"
 #include "ScalarRTCoefficients.h"
 #include "ScalarSpecularInfoMap.h"
 #include "Layer.h"
@@ -35,7 +35,7 @@ TEST_F(ScalarSpecularInfoMapTest, getCoefficients)
 {
     ScalarSpecularInfoMap map(mp_multilayer, 0);
     std::unique_ptr<const ScalarRTCoefficients> P_rt_coeffs(
-        (ScalarRTCoefficients*) map.getOutCoefficients(1.0, 1.0, 2.0*Units::PI));
+        (ScalarRTCoefficients*) map.getOutCoefficients(1.0, 1.0, 2.0*Pi::PI));
     complex_t R0 = complex_t(0.1750375, -0.0222467);
     complex_t lambda0 = complex_t(0.841471, 0.0);
     EXPECT_TRUE(nullptr != P_rt_coeffs.get());
diff --git a/Tests/UnitTests/Core/2/SpecularMatrixTest.h b/Tests/UnitTests/Core/2/SpecularMatrixTest.h
index ab92d80126275f0a6e4f046f04f490a8d2a37312..7fee618141d77514690005fa7857d2985b03e7fb 100644
--- a/Tests/UnitTests/Core/2/SpecularMatrixTest.h
+++ b/Tests/UnitTests/Core/2/SpecularMatrixTest.h
@@ -2,19 +2,16 @@
 #define SPECULARMATRIXTEST_H
 
 #include "SpecularMatrix.h"
+#include "Units.h"
 
 class SpecularMatrixTest : public ::testing :: Test
 {
 protected:
     SpecularMatrixTest();
     virtual ~SpecularMatrixTest(){}
-
 };
 
-SpecularMatrixTest::SpecularMatrixTest()
-{
-
-}
+SpecularMatrixTest::SpecularMatrixTest() {}
 
 TEST_F(SpecularMatrixTest, initial)
 {
diff --git a/Tests/UnitTests/Core/2/SpecularSimulationTest.h b/Tests/UnitTests/Core/2/SpecularSimulationTest.h
index a837d453193e31692f2c47c8e6d2a5b35eb76459..4fc91ac098a5e593dcfdc4dae7e025ded5618dce 100644
--- a/Tests/UnitTests/Core/2/SpecularSimulationTest.h
+++ b/Tests/UnitTests/Core/2/SpecularSimulationTest.h
@@ -6,7 +6,7 @@
 #include "ISampleBuilder.h"
 #include "Exceptions.h"
 #include "FixedBinAxis.h"
-#include "Units.h"
+#include "Pi.h"
 #include "Layer.h"
 #include <iostream>
 
diff --git a/Tests/UnitTests/Core/3/RectangularDetectorTest.h b/Tests/UnitTests/Core/3/RectangularDetectorTest.h
index 0adfe08ffcb8c01e748acb503d21a36725080269..590ed8f3fd65888f423228dbf6b81bf6350c7122 100644
--- a/Tests/UnitTests/Core/3/RectangularDetectorTest.h
+++ b/Tests/UnitTests/Core/3/RectangularDetectorTest.h
@@ -1,15 +1,14 @@
 #ifndef RECTANGULARDETECTORTEST_H
 #define RECTANGULARDETECTORTEST_H
 
-#include "Units.h"
 #include "RectangularDetector.h"
 #include "GISASSimulation.h"
 #include "SimulationElement.h"
 #include "Numeric.h"
+#include "Units.h"
 #include <memory>
 #include <iostream>
 
-
 class RectangularDetectorTest : public ::testing::Test
 {
  protected:
diff --git a/Tests/UnitTests/Core/3/SpecialFunctionsTest.h b/Tests/UnitTests/Core/3/SpecialFunctionsTest.h
index f4e0a4d9cd2d624d086cc98910d28818d4eaaff1..d5d48c3256aab7ee0b43db6c773af71982ba86f9 100644
--- a/Tests/UnitTests/Core/3/SpecialFunctionsTest.h
+++ b/Tests/UnitTests/Core/3/SpecialFunctionsTest.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Tests/UnitTests/Core/3/SpecialFunctionsTest.h
-//! @brief     Declares unit test for Form factors.
+//! @brief     Defines unit test for Form factors.
 //!
 //! @homepage  http://bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -17,6 +17,7 @@
 #define SPECIALFUNCTIONSTEST_H
 
 #include "MathFunctions.h"
+#include "Pi.h"
 
 #define EXPECT_CNEAR(a,b,epsi) \
   EXPECT_NEAR((a).real(),(b).real(),epsi); EXPECT_NEAR((a).imag(),(b).imag(),epsi);
@@ -65,7 +66,7 @@ TEST_F(SpecialFunctionsTest, csinc)
     const double eps = 4.7e-16; // more than twice the machine precision
 
     for( int i=0; i<24; ++i ) {
-        double ph = 2*M_PI*i/24;
+        double ph = Pi::PI2*i/24;
         //std::cout << "---------------------------------------------------------------------\n";
         //std::cout << "phase = " << ph << "\n";
         EXPECT_EQ( MathFunctions::sinc(complex_t(0,0)),       complex_t(1.,0.) );
diff --git a/Tests/UnitTests/Core/4/BeamTest.h b/Tests/UnitTests/Core/4/BeamTest.h
index 8d4bdde410dd530016413ff399988400bf5fefb3..77c4ec6748d855ca088af749d7cb240743543ca5 100644
--- a/Tests/UnitTests/Core/4/BeamTest.h
+++ b/Tests/UnitTests/Core/4/BeamTest.h
@@ -3,7 +3,7 @@
 
 #include "Beam.h"
 #include "BornAgainNamespace.h"
-#include "Units.h"
+#include "Pi.h"
 #include "ParameterPool.h"
 
 #include <memory>
@@ -19,7 +19,7 @@ protected:
 
 TEST_F(BeamTest, BeamInitialState)
 {
-    EXPECT_DOUBLE_EQ(2.0 * Units::PI, m_empty_beam.getCentralK()[0]);
+    EXPECT_DOUBLE_EQ(2.0 * Pi::PI, m_empty_beam.getCentralK()[0]);
     EXPECT_EQ(0.0, m_empty_beam.getCentralK()[1]);
     EXPECT_EQ(0.0, m_empty_beam.getCentralK()[2]);
     EXPECT_EQ(0.0, m_empty_beam.getIntensity());
diff --git a/Tests/UnitTests/Core/4/HomogeneousMagneticMaterialTest.h b/Tests/UnitTests/Core/4/HomogeneousMagneticMaterialTest.h
index acc5e32ba67f3c0051ffc119438fdf062418d264..4621acb97c8a53b62cbf6fa6e7ee2a7f649bdf12 100644
--- a/Tests/UnitTests/Core/4/HomogeneousMagneticMaterialTest.h
+++ b/Tests/UnitTests/Core/4/HomogeneousMagneticMaterialTest.h
@@ -3,6 +3,7 @@
 
 #include "HomogeneousMagneticMaterial.h"
 #include "Rotations.h"
+#include "Units.h"
 
 class HomogeneousMagneticMaterialTest : public ::testing::Test
 {
@@ -39,7 +40,6 @@ TEST_F(HomogeneousMagneticMaterialTest, HomogeneousMagneticMaterialWithRefIndex)
     kvector_t magnetism2 = kvector_t(5.0, 6.0, 7.0);
     material.setMagneticField(magnetism2);
     EXPECT_EQ(magnetism2, material.getMagneticField());
-
 }
 
 TEST_F(HomogeneousMagneticMaterialTest, HomogeneousMagneticMaterialWithRefIndexAndMagField)
@@ -63,7 +63,6 @@ TEST_F(HomogeneousMagneticMaterialTest, HomogeneousMagneticMaterialWithRefIndexA
     kvector_t magnetism2 = kvector_t(5.0, 6.0, 7.0);
     material.setMagneticField(magnetism2);
     EXPECT_EQ(magnetism2, material.getMagneticField());
-
 }
 
 TEST_F(HomogeneousMagneticMaterialTest, HomogeneousMagneticMaterialTransform)
diff --git a/Tests/UnitTests/Core/4/InstrumentTest.h b/Tests/UnitTests/Core/4/InstrumentTest.h
index 5c60805a52022b6c2d3423c21a748206794cd50c..543a398e6039a40e7902f90ec6728754248efad7 100644
--- a/Tests/UnitTests/Core/4/InstrumentTest.h
+++ b/Tests/UnitTests/Core/4/InstrumentTest.h
@@ -1,7 +1,7 @@
 #ifndef INSTRUMENTTEST_H
 #define INSTRUMENTTEST_H
 
-#include "Units.h"
+#include "Pi.h"
 #include "Instrument.h"
 #include "BornAgainNamespace.h"
 
@@ -35,7 +35,7 @@ TEST_F(InstrumentTest, InstrumentInitialState)
 TEST_F(InstrumentTest, BeamManipulation)
 {
     double lambda(1), alpha(-1), phi(1);
-    double k = 2.*Units::PI/lambda;
+    double k = 2.*Pi::PI/lambda;
     double x = k*std::cos(alpha) * std::cos(phi);
     double y = -k*std::cos(alpha) * std::sin(phi);
     double z = k*std::sin(alpha);
diff --git a/Tests/UnitTests/Core/4/Shape2DTest.h b/Tests/UnitTests/Core/4/Shape2DTest.h
index 85f4e82b7c55f815ed2c38e42a76f5c0433d0862..e9abe2f4047949cf9a76763b2b01939fd7d9f1b2 100644
--- a/Tests/UnitTests/Core/4/Shape2DTest.h
+++ b/Tests/UnitTests/Core/4/Shape2DTest.h
@@ -4,7 +4,7 @@
 #include "Rectangle.h"
 #include "Ellipse.h"
 #include "Line.h"
-#include "Units.h"
+#include "Pi.h"
 #include <memory>
 
 class Shape2DTest : public ::testing::Test
diff --git a/Tests/UnitTests/Core/4/ThreadInfoTest.h b/Tests/UnitTests/Core/4/ThreadInfoTest.h
index 093e5abff81b97b865efc2894c5b13eb31980c53..f1021eaaa311c45444b1fafe23cf5241306a1f0f 100644
--- a/Tests/UnitTests/Core/4/ThreadInfoTest.h
+++ b/Tests/UnitTests/Core/4/ThreadInfoTest.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Tests/UnitTests/Core/4/ThreadInfoTest.h
-//! @brief     Declares unit test for ThreadInfo class.
+//! @brief     Defines unit test for ThreadInfo class.
 //!
 //! @homepage  http://bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Tests/UnitTests/Core/5/DistributionsTest.h b/Tests/UnitTests/Core/5/DistributionsTest.h
index 7d81233c6dde40d9661b522a8a0b87ee6f5f5596..85b8aa1722eba03a6614d306921ff19cd539781e 100644
--- a/Tests/UnitTests/Core/5/DistributionsTest.h
+++ b/Tests/UnitTests/Core/5/DistributionsTest.h
@@ -1,7 +1,7 @@
 #ifndef DISTRIBUTIONSTEST_H
 #define DISTRIBUTIONSTEST_H
 
-#include "Units.h"
+#include "Pi.h"
 #include "BornAgainNamespace.h"
 #include "Distributions.h"
 #include "Exceptions.h"
@@ -103,7 +103,7 @@ TEST_F(DistributionsTest, DistributionLorentzDefaultConstructor)
     EXPECT_EQ(0.0, P_distr_lorentz->getMean());
     EXPECT_EQ(1.0, P_distr_lorentz->getHWHM());
     EXPECT_EQ(BornAgain::DistributionLorentzType, P_distr_lorentz->getName());
-    EXPECT_EQ(1/(2*Units::PI), P_distr_lorentz->probabilityDensity(1.0));
+    EXPECT_EQ(1/(2*Pi::PI), P_distr_lorentz->probabilityDensity(1.0));
 
     std::vector<double> list1 = P_distr_lorentz->generateValueList(1, 0.0);
     EXPECT_EQ(P_distr_lorentz->getMean(), list1[0]);
@@ -126,7 +126,7 @@ TEST_F(DistributionsTest, DistributionLorentzConstructor)
     EXPECT_EQ(1.0, distr2.getMean());
     EXPECT_EQ(1.0, distr2.getHWHM());
     EXPECT_EQ(BornAgain::DistributionLorentzType, distr2.getName());
-    EXPECT_EQ(1.0/Units::PI, distr2.probabilityDensity(1.0));
+    EXPECT_EQ(1.0/Pi::PI, distr2.probabilityDensity(1.0));
 
     std::vector<double> list2 = distr2.generateValueList(1, 0.0);
     EXPECT_EQ(distr2.getMean(), list2[0]);
@@ -197,7 +197,7 @@ TEST_F(DistributionsTest, DistributionGaussianDefaultConstructor)
     std::unique_ptr<DistributionGaussian> P_distr_gauss { new DistributionGaussian() };
     EXPECT_EQ(0.0, P_distr_gauss->getMean());
     EXPECT_EQ(1.0, P_distr_gauss->getStdDev());
-    EXPECT_EQ(std::exp(-1.0/2.0)/std::sqrt(2.0*Units::PI), P_distr_gauss->probabilityDensity(1.0));
+    EXPECT_EQ(std::exp(-1.0/2.0)/std::sqrt(2.0*Pi::PI), P_distr_gauss->probabilityDensity(1.0));
     EXPECT_EQ(BornAgain::DistributionGaussianType, P_distr_gauss->getName());
 
     std::vector<double> list1 = P_distr_gauss->generateValueList(1, 0.0);
@@ -220,7 +220,7 @@ TEST_F(DistributionsTest, DistributionGaussianConstructor)
     DistributionGaussian distr2(1.0, 1.0);
     EXPECT_EQ(1.0, distr2.getMean());
     EXPECT_EQ(1.0, distr2.getStdDev());
-    EXPECT_EQ(1/std::sqrt(2.0*Units::PI), distr2.probabilityDensity(1.0));
+    EXPECT_EQ(1/std::sqrt(2.0*Pi::PI), distr2.probabilityDensity(1.0));
     EXPECT_EQ(BornAgain::DistributionGaussianType, distr2.getName());
 
     std::vector<double> list2 = distr2.generateValueList(1, 0.0);
@@ -248,7 +248,7 @@ TEST_F(DistributionsTest, DistributionGaussianClone)
     std::unique_ptr<DistributionGaussian> P_clone { P_distr_gauss->clone() };
     EXPECT_EQ(1.0, P_clone->getMean());
     EXPECT_EQ(1.0, P_clone->getStdDev());
-    EXPECT_EQ(1/std::sqrt(2.0*Units::PI), P_clone->probabilityDensity(1.0));
+    EXPECT_EQ(1/std::sqrt(2.0*Pi::PI), P_clone->probabilityDensity(1.0));
     EXPECT_EQ(BornAgain::DistributionGaussianType, P_clone->getName());
 
     std::vector<double> list1 = P_clone->generateValueList(1, 0.0);
@@ -274,7 +274,7 @@ TEST_F(DistributionsTest, DistributionLogNormalConstructorWithOneParameter)
     EXPECT_EQ(1.0, distr2.getMedian());
     EXPECT_EQ(1.0, distr2.getScalePar());
     EXPECT_EQ(std::exp(0.5), distr2.getMean());
-    EXPECT_EQ(1.0/std::sqrt(2.0*Units::PI), distr2.probabilityDensity(1.0));
+    EXPECT_EQ(1.0/std::sqrt(2.0*Pi::PI), distr2.probabilityDensity(1.0));
     EXPECT_EQ(BornAgain::DistributionLogNormalType, distr2.getName());
 
     std::vector<double> list2 = distr2.generateValueList(1, 0.0);
@@ -291,7 +291,7 @@ TEST_F(DistributionsTest, DistributionLogNormalConstructorWithTwoParameter)
     EXPECT_EQ(1.0, P_distr_lognormal->getMedian());
     EXPECT_EQ(1.0, P_distr_lognormal->getScalePar());
     EXPECT_EQ(std::exp(0.5), P_distr_lognormal->getMean());
-    EXPECT_EQ(1.0/std::sqrt(2.0*Units::PI), P_distr_lognormal->probabilityDensity(1.0));
+    EXPECT_EQ(1.0/std::sqrt(2.0*Pi::PI), P_distr_lognormal->probabilityDensity(1.0));
     EXPECT_EQ(BornAgain::DistributionLogNormalType, P_distr_lognormal->getName());
 
     std::vector<double> list1 = P_distr_lognormal->generateValueList(1, 0.0);
@@ -320,7 +320,7 @@ TEST_F(DistributionsTest, DistributionLogNormalClone)
     EXPECT_EQ(1.0, P_distr_lognormal->getMedian());
     EXPECT_EQ(1.0, P_distr_lognormal->getScalePar());
     EXPECT_EQ(std::exp(0.5), P_distr_lognormal->getMean());
-    EXPECT_EQ(1/std::sqrt(2.0*Units::PI), P_distr_lognormal->probabilityDensity(1.0));
+    EXPECT_EQ(1/std::sqrt(2.0*Pi::PI), P_distr_lognormal->probabilityDensity(1.0));
     EXPECT_EQ(BornAgain::DistributionLogNormalType, P_distr_lognormal->getName());
 
     std::vector<double> list1 = P_distr_lognormal->generateValueList(1, 0.0);
@@ -338,7 +338,7 @@ TEST_F(DistributionsTest, DistributionCosineDefaultConstructor)
     std::unique_ptr<DistributionCosine> P_distr_cosine { new DistributionCosine() };
     EXPECT_EQ(0.0, P_distr_cosine->getMean());
     EXPECT_EQ(1.0, P_distr_cosine->getSigma());
-    EXPECT_DOUBLE_EQ((1.0+std::cos(1.0))/(2.0*Units::PI), P_distr_cosine->probabilityDensity(1.0));
+    EXPECT_DOUBLE_EQ((1.0+std::cos(1.0))/(2.0*Pi::PI), P_distr_cosine->probabilityDensity(1.0));
     EXPECT_EQ(0, P_distr_cosine->probabilityDensity(100.0));
     EXPECT_EQ(BornAgain::DistributionCosineType, P_distr_cosine->getName());
 
@@ -346,8 +346,8 @@ TEST_F(DistributionsTest, DistributionCosineDefaultConstructor)
     EXPECT_EQ(P_distr_cosine->getMean(), list1[0]);
 
     std::vector<double> list2 = P_distr_cosine->generateValueList(2, 0.0);
-    EXPECT_EQ(-Units::PI, list2[0]);
-    EXPECT_EQ(Units::PI, list2[1]);
+    EXPECT_EQ(-Pi::PI, list2[0]);
+    EXPECT_EQ(Pi::PI, list2[1]);
 }
 
 TEST_F(DistributionsTest, DistributionCosineConstructor)
@@ -362,7 +362,7 @@ TEST_F(DistributionsTest, DistributionCosineConstructor)
     DistributionCosine distr2(1.0,1.0);
     EXPECT_EQ(1.0, distr2.getMean());
     EXPECT_EQ(1.0, distr2.getSigma());
-    EXPECT_EQ(2.0/(2.0*Units::PI), distr2.probabilityDensity(1.0));
+    EXPECT_EQ(2.0/(2.0*Pi::PI), distr2.probabilityDensity(1.0));
     EXPECT_EQ(0, distr2.probabilityDensity(100.0));
     EXPECT_EQ(BornAgain::DistributionCosineType, distr2.getName());
 
@@ -370,8 +370,8 @@ TEST_F(DistributionsTest, DistributionCosineConstructor)
     EXPECT_EQ(distr2.getMean(), list2[0]);
 
     std::vector<double> list3 = distr2.generateValueList(2, 0.0);
-    EXPECT_EQ(1-Units::PI, list3[0]);
-    EXPECT_EQ(1+Units::PI, list3[1]);
+    EXPECT_EQ(1-Pi::PI, list3[0]);
+    EXPECT_EQ(1+Pi::PI, list3[1]);
 }
 
 TEST_F(DistributionsTest, DistributionCosineParameters)
@@ -389,7 +389,7 @@ TEST_F(DistributionsTest, DistributionCosineClone)
     std::unique_ptr<DistributionCosine> P_clone { P_distr_cosine->clone() };
     EXPECT_EQ(1.0, P_clone->getMean());
     EXPECT_EQ(1.0, P_clone->getSigma());
-    EXPECT_EQ(2.0/(2.0*Units::PI), P_clone->probabilityDensity(1.0));
+    EXPECT_EQ(2.0/(2.0*Pi::PI), P_clone->probabilityDensity(1.0));
     EXPECT_EQ(0, P_distr_cosine->probabilityDensity(100.0));
     EXPECT_EQ(BornAgain::DistributionCosineType, P_clone->getName());
 
@@ -397,8 +397,8 @@ TEST_F(DistributionsTest, DistributionCosineClone)
     EXPECT_EQ(P_clone->getMean(), list1[0]);
 
     std::vector<double> list2 = P_clone->generateValueList(2, 0.0);
-    EXPECT_EQ(1-Units::PI, list2[0]);
-    EXPECT_EQ(1+Units::PI, list2[1]);
+    EXPECT_EQ(1-Pi::PI, list2[0]);
+    EXPECT_EQ(1+Pi::PI, list2[1]);
 }
 
 #endif // DISTRIBUTIONSTEST_H
diff --git a/Tests/UnitTests/Core/5/FTDistributionsTest.h b/Tests/UnitTests/Core/5/FTDistributionsTest.h
index ae0218b28fc8276b62b253e42a4055eeae9f8553..9e9b3e3f2713b5bb0a206b31a1526c8dba6b61f5 100644
--- a/Tests/UnitTests/Core/5/FTDistributionsTest.h
+++ b/Tests/UnitTests/Core/5/FTDistributionsTest.h
@@ -4,7 +4,7 @@
 #include "FTDistributions1D.h"
 #include "FTDistributions2D.h"
 #include "BornAgainNamespace.h"
-#include "Units.h"
+#include "Pi.h"
 #include <memory>
 
 using namespace BornAgain;
@@ -155,7 +155,7 @@ TEST_F(FTDistributionsTest, FTDistribution2DCauchyConstructor)
     EXPECT_EQ(2.0, P_2d_cauchy->getCoherenceLengthY());
     EXPECT_EQ(2.0, P_2d_cauchy->getParameter("CoherenceLengthY")->getValue());
     EXPECT_EQ(0, P_2d_cauchy->getParameter("Gamma")->getValue());
-    EXPECT_EQ(Units::PI/2.0, P_2d_cauchy->getDelta());
+    EXPECT_EQ(Pi::PI/2.0, P_2d_cauchy->getDelta());
     EXPECT_EQ(0.0, P_2d_cauchy->getGamma());
     EXPECT_EQ(FTDistribution2DCauchyType, P_2d_cauchy->getName());
     EXPECT_NEAR(0.343206, P_2d_cauchy->evaluate(0.2, 0.5),0.000001);
@@ -177,7 +177,7 @@ TEST_F(FTDistributionsTest, FTDistribution2DCauchyClone)
 
     EXPECT_EQ(5.0, P_clone->getCoherenceLengthX());
     EXPECT_EQ(2.3, P_clone->getCoherenceLengthY());
-    EXPECT_EQ(Units::PI/2.0, P_clone->getDelta());
+    EXPECT_EQ(Pi::PI/2.0, P_clone->getDelta());
     EXPECT_EQ(0.0, P_clone->getGamma());
     EXPECT_EQ(FTDistribution2DCauchyType, P_clone->getName());
     EXPECT_NEAR(0.165121078, P_clone->evaluate(0.2, 0.5),0.000001);
@@ -188,7 +188,7 @@ TEST_F(FTDistributionsTest, FTDistribution2DGaussConstructor)
     std::unique_ptr<IFTDistribution2D> P_2d_gauss { new FTDistribution2DGauss(1.0,2.0) };
     EXPECT_EQ(1.0, P_2d_gauss->getCoherenceLengthX());
     EXPECT_EQ(2.0, P_2d_gauss->getCoherenceLengthY());
-    EXPECT_EQ(Units::PI/2.0, P_2d_gauss->getDelta());
+    EXPECT_EQ(Pi::PI/2.0, P_2d_gauss->getDelta());
     EXPECT_EQ(0.0, P_2d_gauss->getGamma());
     EXPECT_EQ(FTDistribution2DGaussType, P_2d_gauss->getName());
     EXPECT_NEAR(0.5945205, P_2d_gauss->evaluate(0.2, 0.5),0.000001);
@@ -204,7 +204,7 @@ TEST_F(FTDistributionsTest, FTDistribution2DGaussClone)
 
     EXPECT_EQ(5.0, P_clone->getCoherenceLengthX());
     EXPECT_EQ(2.3, P_clone->getCoherenceLengthY());
-    EXPECT_EQ(Units::PI/2.0, P_clone->getDelta());
+    EXPECT_EQ(Pi::PI/2.0, P_clone->getDelta());
     EXPECT_EQ(0.0, P_clone->getGamma());
     EXPECT_EQ(FTDistribution2DGaussType, P_clone->getName());
     EXPECT_NEAR(0.3130945, P_clone->evaluate(0.2, 0.5),0.000001);
@@ -215,7 +215,7 @@ TEST_F(FTDistributionsTest, FTDistribution2DGateConstructor)
     std::unique_ptr<IFTDistribution2D> P_2d_gate { new FTDistribution2DGate(1.0,2.0) };
     EXPECT_EQ(1.0, P_2d_gate->getCoherenceLengthX());
     EXPECT_EQ(2.0, P_2d_gate->getCoherenceLengthY());
-    EXPECT_EQ(Units::PI/2.0, P_2d_gate->getDelta());
+    EXPECT_EQ(Pi::PI/2.0, P_2d_gate->getDelta());
     EXPECT_EQ(0.0, P_2d_gate->getGamma());
     EXPECT_EQ(FTDistribution2DGateType, P_2d_gate->getName());
     EXPECT_NEAR(0.875513, P_2d_gate->evaluate(0.2, 0.5),0.000001);
@@ -231,7 +231,7 @@ TEST_F(FTDistributionsTest, FTDistribution2DGateClone)
 
     EXPECT_EQ(5.0, P_clone->getCoherenceLengthX());
     EXPECT_EQ(2.3, P_clone->getCoherenceLengthY());
-    EXPECT_EQ(Units::PI/2.0, P_clone->getDelta());
+    EXPECT_EQ(Pi::PI/2.0, P_clone->getDelta());
     EXPECT_EQ(0.0, P_clone->getGamma());
     EXPECT_EQ(FTDistribution2DGateType, P_clone->getName());
     EXPECT_NEAR(0.736461, P_clone->evaluate(0.2, 0.5),0.000001);
@@ -242,7 +242,7 @@ TEST_F(FTDistributionsTest, FTDistribution2DConeConstructor)
     std::unique_ptr<IFTDistribution2D> P_2d_cone { new FTDistribution2DCone(1.0,2.0) };
     EXPECT_EQ(1.0, P_2d_cone->getCoherenceLengthX());
     EXPECT_EQ(2.0, P_2d_cone->getCoherenceLengthY());
-    EXPECT_EQ(Units::PI/2.0, P_2d_cone->getDelta());
+    EXPECT_EQ(Pi::PI/2.0, P_2d_cone->getDelta());
     EXPECT_EQ(0.0, P_2d_cone->getGamma());
     EXPECT_EQ(FTDistribution2DConeType, P_2d_cone->getName());
     EXPECT_NEAR(0.924374, P_2d_cone->evaluate(0.2, 0.5),0.000001);
@@ -258,7 +258,7 @@ TEST_F(FTDistributionsTest, FTDistribution2DConeClone)
 
     EXPECT_EQ(5.0, P_clone->getCoherenceLengthX());
     EXPECT_EQ(2.3, P_clone->getCoherenceLengthY());
-    EXPECT_EQ(Units::PI/2.0, P_clone->getDelta());
+    EXPECT_EQ(Pi::PI/2.0, P_clone->getDelta());
     EXPECT_EQ(0.0, P_clone->getGamma());
     EXPECT_EQ(FTDistribution2DConeType, P_clone->getName());
     EXPECT_NEAR(0.837410, P_clone->evaluate(0.2, 0.5),0.000001);
@@ -269,7 +269,7 @@ TEST_F(FTDistributionsTest, FTDistribution2DVoigtConstructor)
     std::unique_ptr<IFTDistribution2D> P_2d_voigt { new FTDistribution2DVoigt(1.0,2.0,3.5) };
     EXPECT_EQ(1.0, P_2d_voigt->getCoherenceLengthX());
     EXPECT_EQ(2.0, P_2d_voigt->getCoherenceLengthY());
-    EXPECT_EQ(Units::PI/2.0, P_2d_voigt->getDelta());
+    EXPECT_EQ(Pi::PI/2.0, P_2d_voigt->getDelta());
     EXPECT_EQ(0.0, P_2d_voigt->getGamma());
     EXPECT_EQ(FTDistribution2DVoigtType, P_2d_voigt->getName());
     EXPECT_NEAR(1.2228072, P_2d_voigt->evaluate(0.2, 0.5),0.000001);
@@ -285,7 +285,7 @@ TEST_F(FTDistributionsTest, FTDistribution2DVoigtClone)
 
     EXPECT_EQ(5.0, P_clone->getCoherenceLengthX());
     EXPECT_EQ(2.3, P_clone->getCoherenceLengthY());
-    EXPECT_EQ(Units::PI/2.0, P_clone->getDelta());
+    EXPECT_EQ(Pi::PI/2.0, P_clone->getDelta());
     EXPECT_EQ(0.0, P_clone->getGamma());
     EXPECT_EQ(FTDistribution2DVoigtType, P_clone->getName());
     EXPECT_NEAR(-0.6635305, P_clone->evaluate(0.2, 0.5),0.000001);
diff --git a/Tests/UnitTests/Core/Numeric/FormFactorSpecializationTest.h b/Tests/UnitTests/Core/Numeric/FormFactorSpecializationTest.h
index 5ae8e601b7fc73fa818d00651b79ec77cf890359..0f9e9cb4fab620df0e6f019bd05f7c9cb4139e75 100644
--- a/Tests/UnitTests/Core/Numeric/FormFactorSpecializationTest.h
+++ b/Tests/UnitTests/Core/Numeric/FormFactorSpecializationTest.h
@@ -13,7 +13,7 @@
 //
 // ************************************************************************** //
 
-#include "Units.h"
+#include "Pi.h"
 #include "BornAgainNamespace.h"
 #include "HardParticles.h"
 #include "qLoopedTest.h"
@@ -65,7 +65,7 @@ TEST_P(FFSpecializationTest, Pyramid3AsPrism)
     if( skip_q( 1e-99, 5e3 ) )
         return;
     double L=1.8, H=.3;
-    FormFactorTetrahedron p0(L, H, Units::PI/2);
+    FormFactorTetrahedron p0(L, H, Pi::PI/2);
     FormFactorPrism3 p1(L, H);
     test_ff_eq( &p0, &p1, eps_polyh );
 }
@@ -75,7 +75,7 @@ TEST_P(FFSpecializationTest, PyramidAsBox)
     if( skip_q( 1e-99, 5e2 ) )
         return;
     double L=1.8, H=.3;
-    FormFactorPyramid p0(L, H, Units::PI/2);
+    FormFactorPyramid p0(L, H, Pi::PI/2);
     FormFactorBox p1(L, L, H);
     test_ff_eq( &p0, &p1, eps_polyh );
 }
@@ -85,7 +85,7 @@ TEST_P(FFSpecializationTest, Cone6AsPrism)
     if( skip_q( 1e-99, 5e2 ) )
         return;
     double L=.8, H=1.13;
-    FormFactorCone6 p0(L, H, Units::PI/2);
+    FormFactorCone6 p0(L, H, Pi::PI/2);
     FormFactorPrism6 p1(L, H);
     test_ff_eq( &p0, &p1, eps_polyh );
 }
diff --git a/Tests/UnitTests/Core/Numeric/FormFactorSymmetryTest.h b/Tests/UnitTests/Core/Numeric/FormFactorSymmetryTest.h
index 9dee4291128225ba5c999ce15c6ef93c94e3a4c6..de0539c968d821f196286e34d394aa03233e5f22 100644
--- a/Tests/UnitTests/Core/Numeric/FormFactorSymmetryTest.h
+++ b/Tests/UnitTests/Core/Numeric/FormFactorSymmetryTest.h
@@ -13,7 +13,7 @@
 //
 // ************************************************************************** //
 
-#include "Units.h"
+#include "Pi.h"
 #include "BornAgainNamespace.h"
 #include "HardParticles.h"
 #include "qLoopedTest.h"
@@ -43,7 +43,7 @@ TEST_P(FFSymmetryTest, Prism3)
     if( skip_q( 1e-99, 2e2 ) )
         return;
     FormFactorPrism3 p(.83, .45);
-    test_qq_eq( &p, q, q.rotatedZ(Units::PI2/3) );
+    test_qq_eq( &p, q, q.rotatedZ(Pi::PI2/3) );
 }
 
 TEST_P(FFSymmetryTest, Prism6)
@@ -51,8 +51,8 @@ TEST_P(FFSymmetryTest, Prism6)
     if( skip_q( 1e-99, 2e3 ) )
         return;
     FormFactorPrism6 p(1.33, .42);
-    test_qq_eq( &p, q, q.rotatedZ( Units::PI/3),  1e-12 );
-    test_qq_eq( &p, q, q.rotatedZ(-Units::PI2/3), 3.8e-12 );
+    test_qq_eq( &p, q, q.rotatedZ( Pi::PI/3),  1e-12 );
+    test_qq_eq( &p, q, q.rotatedZ(-Pi::PI2/3), 3.8e-12 );
 }
 
 TEST_P(FFSymmetryTest, Tetrahedron)
@@ -60,7 +60,7 @@ TEST_P(FFSymmetryTest, Tetrahedron)
     if( skip_q( 1e-99, 2e2 ) )
         return;
     FormFactorTetrahedron p(8.43, .25, .53);
-    test_qq_eq( &p, q, q.rotatedZ(Units::PI2/3), 6e-12 );
+    test_qq_eq( &p, q, q.rotatedZ(Pi::PI2/3), 6e-12 );
     // Linux: 3e-12, relaxed for Mac
 }
 
@@ -69,15 +69,15 @@ TEST_P(FFSymmetryTest, Cone6_flat)
     if( skip_q( 1e-99, 2e2) ) // TODO for larger q, imag(ff) is nan
         return;
     FormFactorCone6 p(4.3, .09, .1);
-    test_qq_eq( &p, q, q.rotatedZ(-Units::PI/3), 3.8e-12 );
+    test_qq_eq( &p, q, q.rotatedZ(-Pi::PI/3), 3.8e-12 );
 }
 
 TEST_P(FFSymmetryTest, Cone6_steep)
 {
     if( skip_q( 1e-99, 2e2) ) // TODO for larger q, imag(ff) is nan
         return;
-    FormFactorCone6 p(.23, 3.5, .999*Units::PI/2);
-    test_qq_eq( &p, q, q.rotatedZ(-Units::PI/3), 2.5e-12 );
+    FormFactorCone6 p(.23, 3.5, .999*Pi::PI/2);
+    test_qq_eq( &p, q, q.rotatedZ(-Pi::PI/3), 2.5e-12 );
 }
 
 //*********** spheroids ***************
@@ -96,7 +96,7 @@ TEST_P(FFSymmetryTest, TruncatedSphere)
     if( skip_q( 1e-99, 2e2 ) )
         return;
     FormFactorTruncatedSphere p(.79, .34);
-    test_qq_eq( &p, q, q.rotatedZ(Units::PI/3.13698), 1e-10 );
+    test_qq_eq( &p, q, q.rotatedZ(Pi::PI/3.13698), 1e-10 );
 }
 
 // ****** TODO: tests that do not pass for the full q range *********
diff --git a/Tests/UnitTests/Fit/FitObjectTest.h b/Tests/UnitTests/Fit/FitObjectTest.h
index e5ee61e6b586e8fc72aa46498198736d403334b6..d2994655931e681e8961b21c06e4ae1623aae776 100644
--- a/Tests/UnitTests/Fit/FitObjectTest.h
+++ b/Tests/UnitTests/Fit/FitObjectTest.h
@@ -1,10 +1,10 @@
 #ifndef FITOBJECTTEST_H
 #define FITOBJECTTEST_H
 
-#include "Units.h"
 #include "FitObject.h"
 #include "GISASSimulation.h"
 #include "BornAgainNamespace.h"
+#include "Units.h"
 #include <iostream>
 #include "gtest/gtest.h"
 
@@ -17,8 +17,6 @@ class FitObjectTest : public ::testing::Test
 
 };
 
-
-
 TEST_F(FitObjectTest, Initialization)
 {
     EXPECT_EQ(1, 1);
@@ -44,7 +42,4 @@ TEST_F(FitObjectTest, Initialization)
     EXPECT_TRUE(obj.getSimulation()->getOutputData()->hasSameShape(*obj.getRealData()));
 }
 
-
-
-
 #endif // FITOBJECTTEST_H
diff --git a/Tests/UnitTests/GUI/TestGUICoreObjectCorrespondence.cpp b/Tests/UnitTests/GUI/TestGUICoreObjectCorrespondence.cpp
index 046eca801ec9fb4612af4d71b84268ed7e28d236..1dd4bdd155693f53115338284314fa45b6b03f3a 100644
--- a/Tests/UnitTests/GUI/TestGUICoreObjectCorrespondence.cpp
+++ b/Tests/UnitTests/GUI/TestGUICoreObjectCorrespondence.cpp
@@ -6,7 +6,6 @@
 #include "InterferenceFunctionItems.h"
 #include "Units.h"
 
-
 void TestGUICoreObjectCorrespondence::test_AnisoPyramid()
 {
     AnisoPyramidItem gui_anisopyramid;
diff --git a/Tests/UnitTests/GUI/verify_throw_macro.h b/Tests/UnitTests/GUI/verify_throw_macro.h
index 83b68a37b115650f85669ac15ddb547beb9cd5f5..6b5dfafae1f66ee49b253514b20a12d00a54e758 100644
--- a/Tests/UnitTests/GUI/verify_throw_macro.h
+++ b/Tests/UnitTests/GUI/verify_throw_macro.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Tests/UnitTests/GUI/verify_throw_macro.h
-//! @brief     Declares macro to test exception throw
+//! @brief     Defines macro to test exception throw
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/Wrap/WinDllMacros.h b/Wrap/WinDllMacros.h
index 9f343ae3c011c6a8668fb0a949891370036389ff..cda5600355d7b916a47b01975a3184de1ba01f34 100644
--- a/Wrap/WinDllMacros.h
+++ b/Wrap/WinDllMacros.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      Wrap/WinDllMacros.h
-//! @brief     Declares macroses for building dll.
+//! @brief     Defines macroses for building dll.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
diff --git a/auto/Wrap/doxygen_core.i b/auto/Wrap/doxygen_core.i
index 4a5b643a59d8a18dc2993c31966f0c6051d693a1..04e8a6b0154ab37fb28a972de24f928c07ae6ff5 100644
--- a/auto/Wrap/doxygen_core.i
+++ b/auto/Wrap/doxygen_core.i
@@ -4806,7 +4806,7 @@ C++ includes: FTDecayFunctions.h
 C++ includes: FTDecayFunctions.h
 ";
 
-%feature("docstring")  FTDecayFunction2DCauchy::FTDecayFunction2DCauchy "FTDecayFunction2DCauchy::FTDecayFunction2DCauchy(double decay_length_x, double decay_length_y, double gamma=0, double delta=Units::PID2)
+%feature("docstring")  FTDecayFunction2DCauchy::FTDecayFunction2DCauchy "FTDecayFunction2DCauchy::FTDecayFunction2DCauchy(double decay_length_x, double decay_length_y, double gamma=0, double delta=Pi::PID2)
 ";
 
 %feature("docstring")  FTDecayFunction2DCauchy::~FTDecayFunction2DCauchy "virtual FTDecayFunction2DCauchy::~FTDecayFunction2DCauchy()
@@ -4829,7 +4829,7 @@ evaluate Fourier transformed decay function for q in X,Y coordinates
 C++ includes: FTDecayFunctions.h
 ";
 
-%feature("docstring")  FTDecayFunction2DGauss::FTDecayFunction2DGauss "FTDecayFunction2DGauss::FTDecayFunction2DGauss(double decay_length_x, double decay_length_y, double gamma=0, double delta=Units::PID2)
+%feature("docstring")  FTDecayFunction2DGauss::FTDecayFunction2DGauss "FTDecayFunction2DGauss::FTDecayFunction2DGauss(double decay_length_x, double decay_length_y, double gamma=0, double delta=Pi::PID2)
 ";
 
 %feature("docstring")  FTDecayFunction2DGauss::~FTDecayFunction2DGauss "virtual FTDecayFunction2DGauss::~FTDecayFunction2DGauss()
@@ -4852,7 +4852,7 @@ evaluate Fourier transformed decay function for q in X,Y coordinates
 C++ includes: FTDecayFunctions.h
 ";
 
-%feature("docstring")  FTDecayFunction2DVoigt::FTDecayFunction2DVoigt "FTDecayFunction2DVoigt::FTDecayFunction2DVoigt(double decay_length_x, double decay_length_y, double eta, double gamma=0, double delta=Units::PID2)
+%feature("docstring")  FTDecayFunction2DVoigt::FTDecayFunction2DVoigt "FTDecayFunction2DVoigt::FTDecayFunction2DVoigt(double decay_length_x, double decay_length_y, double eta, double gamma=0, double delta=Pi::PID2)
 ";
 
 %feature("docstring")  FTDecayFunction2DVoigt::~FTDecayFunction2DVoigt "virtual FTDecayFunction2DVoigt::~FTDecayFunction2DVoigt()
@@ -5007,7 +5007,7 @@ C++ includes: FTDistributions1D.h
 C++ includes: FTDistributions2D.h
 ";
 
-%feature("docstring")  FTDistribution2DCauchy::FTDistribution2DCauchy "FTDistribution2DCauchy::FTDistribution2DCauchy(double coherence_length_x, double coherence_length_y, double gamma=0, double delta=Units::PID2)
+%feature("docstring")  FTDistribution2DCauchy::FTDistribution2DCauchy "FTDistribution2DCauchy::FTDistribution2DCauchy(double coherence_length_x, double coherence_length_y, double gamma=0, double delta=Pi::PID2)
 ";
 
 %feature("docstring")  FTDistribution2DCauchy::~FTDistribution2DCauchy "virtual FTDistribution2DCauchy::~FTDistribution2DCauchy()
@@ -5030,7 +5030,7 @@ evaluate Fourier transformed distribution for q in X,Y coordinates the original
 C++ includes: FTDistributions2D.h
 ";
 
-%feature("docstring")  FTDistribution2DCone::FTDistribution2DCone "FTDistribution2DCone::FTDistribution2DCone(double coherence_length_x, double coherence_length_y, double gamma=0, double delta=Units::PID2)
+%feature("docstring")  FTDistribution2DCone::FTDistribution2DCone "FTDistribution2DCone::FTDistribution2DCone(double coherence_length_x, double coherence_length_y, double gamma=0, double delta=Pi::PID2)
 ";
 
 %feature("docstring")  FTDistribution2DCone::~FTDistribution2DCone "virtual FTDistribution2DCone::~FTDistribution2DCone()
@@ -5053,7 +5053,7 @@ evaluate Fourier transformed distribution for q in X,Y coordinates the original
 C++ includes: FTDistributions2D.h
 ";
 
-%feature("docstring")  FTDistribution2DGate::FTDistribution2DGate "FTDistribution2DGate::FTDistribution2DGate(double coherence_length_x, double coherence_length_y, double gamma=0, double delta=Units::PID2)
+%feature("docstring")  FTDistribution2DGate::FTDistribution2DGate "FTDistribution2DGate::FTDistribution2DGate(double coherence_length_x, double coherence_length_y, double gamma=0, double delta=Pi::PID2)
 ";
 
 %feature("docstring")  FTDistribution2DGate::~FTDistribution2DGate "virtual FTDistribution2DGate::~FTDistribution2DGate()
@@ -5076,7 +5076,7 @@ evaluate Fourier transformed distribution for q in X,Y coordinates the original
 C++ includes: FTDistributions2D.h
 ";
 
-%feature("docstring")  FTDistribution2DGauss::FTDistribution2DGauss "FTDistribution2DGauss::FTDistribution2DGauss(double coherence_length_x, double coherence_length_y, double gamma=0, double delta=Units::PID2)
+%feature("docstring")  FTDistribution2DGauss::FTDistribution2DGauss "FTDistribution2DGauss::FTDistribution2DGauss(double coherence_length_x, double coherence_length_y, double gamma=0, double delta=Pi::PID2)
 ";
 
 %feature("docstring")  FTDistribution2DGauss::~FTDistribution2DGauss "virtual FTDistribution2DGauss::~FTDistribution2DGauss()
@@ -5099,7 +5099,7 @@ evaluate Fourier transformed distribution for q in X,Y coordinates the original
 C++ includes: FTDistributions2D.h
 ";
 
-%feature("docstring")  FTDistribution2DVoigt::FTDistribution2DVoigt "FTDistribution2DVoigt::FTDistribution2DVoigt(double coherence_length_x, double coherence_length_y, double eta, double gamma=0, double delta=Units::PID2)
+%feature("docstring")  FTDistribution2DVoigt::FTDistribution2DVoigt "FTDistribution2DVoigt::FTDistribution2DVoigt(double coherence_length_x, double coherence_length_y, double eta, double gamma=0, double delta=Pi::PID2)
 ";
 
 %feature("docstring")  FTDistribution2DVoigt::~FTDistribution2DVoigt "virtual FTDistribution2DVoigt::~FTDistribution2DVoigt()
@@ -6504,7 +6504,7 @@ Interface for 2 dimensional decay function in reciprocal space.
 C++ includes: FTDecayFunctions.h
 ";
 
-%feature("docstring")  IFTDecayFunction2D::IFTDecayFunction2D "IFTDecayFunction2D::IFTDecayFunction2D(double decay_length_x, double decay_length_y, double gamma=0, double delta=Units::PID2)
+%feature("docstring")  IFTDecayFunction2D::IFTDecayFunction2D "IFTDecayFunction2D::IFTDecayFunction2D(double decay_length_x, double decay_length_y, double gamma=0, double delta=Pi::PID2)
 ";
 
 %feature("docstring")  IFTDecayFunction2D::~IFTDecayFunction2D "virtual IFTDecayFunction2D::~IFTDecayFunction2D()
@@ -6584,7 +6584,7 @@ Interface for 2 dimensional distributions in Fourier space.
 C++ includes: FTDistributions2D.h
 ";
 
-%feature("docstring")  IFTDistribution2D::IFTDistribution2D "IFTDistribution2D::IFTDistribution2D(double coherence_length_x, double coherence_length_y, double gamma=0, double delta=Units::PID2)
+%feature("docstring")  IFTDistribution2D::IFTDistribution2D "IFTDistribution2D::IFTDistribution2D(double coherence_length_x, double coherence_length_y, double gamma=0, double delta=Pi::PID2)
 ";
 
 %feature("docstring")  IFTDistribution2D::~IFTDistribution2D "virtual IFTDistribution2D::~IFTDistribution2D()
@@ -13406,13 +13406,13 @@ C++ includes: WavevectorInfo.h
 // File: classMathFunctions_1_1Convolve_1_1Workspace.xml
 
 
-// File: namespace_0D294.xml
+// File: namespace_0D295.xml
 
 
-// File: namespace_0D367.xml
+// File: namespace_0D368.xml
 
 
-// File: namespace_0D433.xml
+// File: namespace_0D434.xml
 
 
 // File: namespaceboost_1_1geometry.xml
@@ -13455,6 +13455,11 @@ creates directory in current directory
 join paths together 
 ";
 
+%feature("docstring")  FileSystem::filename "std::string FileSystem::filename(const std::string &path)
+
+Returns path without directory part (\"Foo/Bar/Doz.int.gz\" -> \"Doz.int.gz\") 
+";
+
 %feature("docstring")  FileSystem::glob "std::vector< std::string > FileSystem::glob(const std::string &pattern)
 
 Returns file names that agree with glob pattern. 
@@ -13747,6 +13752,9 @@ Parse double values from string to vector of double.
 ";
 
 
+// File: namespacePi.xml
+
+
 // File: namespacePythonFormatting.xml
 %feature("docstring")  PythonFormatting::getRepresentation "BA_CORE_API_ std::string PythonFormatting::getRepresentation(const IDistribution1D *distribution)
 
@@ -14006,6 +14014,9 @@ Returns exp(I*z), where I is the imaginary unit.
 // File: Macros_8h.xml
 
 
+// File: Pi_8h.xml
+
+
 // File: SafePointerVector_8h.xml
 
 
diff --git a/auto/Wrap/libBornAgainCore.py b/auto/Wrap/libBornAgainCore.py
index f9266877414fb10412fbc158e5c7b6783e9e1e1c..242bd2610fe85da99ca50431a632d51e0e12bb97 100644
--- a/auto/Wrap/libBornAgainCore.py
+++ b/auto/Wrap/libBornAgainCore.py
@@ -2787,10 +2787,6 @@ class WavevectorInfo(_object):
     __del__ = lambda self: None
 WavevectorInfo_swigregister = _libBornAgainCore.WavevectorInfo_swigregister
 WavevectorInfo_swigregister(WavevectorInfo)
-PI = cvar.PI
-PID2 = cvar.PID2
-PID4 = cvar.PID4
-PI_SQR = cvar.PI_SQR
 nanometer = cvar.nanometer
 angstrom = cvar.angstrom
 micrometer = cvar.micrometer
@@ -8740,7 +8736,7 @@ class FTDecayFunction2DCauchy(IFTDecayFunction2D):
         __init__(FTDecayFunction2DCauchy self, double decay_length_x, double decay_length_y, double gamma=0) -> FTDecayFunction2DCauchy
         __init__(FTDecayFunction2DCauchy self, double decay_length_x, double decay_length_y) -> FTDecayFunction2DCauchy
 
-        FTDecayFunction2DCauchy::FTDecayFunction2DCauchy(double decay_length_x, double decay_length_y, double gamma=0, double delta=Units::PID2)
+        FTDecayFunction2DCauchy::FTDecayFunction2DCauchy(double decay_length_x, double decay_length_y, double gamma=0, double delta=Pi::PID2)
 
         """
         this = _libBornAgainCore.new_FTDecayFunction2DCauchy(*args)
@@ -8800,7 +8796,7 @@ class FTDecayFunction2DGauss(IFTDecayFunction2D):
         __init__(FTDecayFunction2DGauss self, double decay_length_x, double decay_length_y, double gamma=0) -> FTDecayFunction2DGauss
         __init__(FTDecayFunction2DGauss self, double decay_length_x, double decay_length_y) -> FTDecayFunction2DGauss
 
-        FTDecayFunction2DGauss::FTDecayFunction2DGauss(double decay_length_x, double decay_length_y, double gamma=0, double delta=Units::PID2)
+        FTDecayFunction2DGauss::FTDecayFunction2DGauss(double decay_length_x, double decay_length_y, double gamma=0, double delta=Pi::PID2)
 
         """
         this = _libBornAgainCore.new_FTDecayFunction2DGauss(*args)
@@ -8860,7 +8856,7 @@ class FTDecayFunction2DVoigt(IFTDecayFunction2D):
         __init__(FTDecayFunction2DVoigt self, double decay_length_x, double decay_length_y, double eta, double gamma=0) -> FTDecayFunction2DVoigt
         __init__(FTDecayFunction2DVoigt self, double decay_length_x, double decay_length_y, double eta) -> FTDecayFunction2DVoigt
 
-        FTDecayFunction2DVoigt::FTDecayFunction2DVoigt(double decay_length_x, double decay_length_y, double eta, double gamma=0, double delta=Units::PID2)
+        FTDecayFunction2DVoigt::FTDecayFunction2DVoigt(double decay_length_x, double decay_length_y, double eta, double gamma=0, double delta=Pi::PID2)
 
         """
         this = _libBornAgainCore.new_FTDecayFunction2DVoigt(*args)
@@ -9440,7 +9436,7 @@ class FTDistribution2DCauchy(IFTDistribution2D):
         __init__(FTDistribution2DCauchy self, double coherence_length_x, double coherence_length_y, double gamma=0) -> FTDistribution2DCauchy
         __init__(FTDistribution2DCauchy self, double coherence_length_x, double coherence_length_y) -> FTDistribution2DCauchy
 
-        FTDistribution2DCauchy::FTDistribution2DCauchy(double coherence_length_x, double coherence_length_y, double gamma=0, double delta=Units::PID2)
+        FTDistribution2DCauchy::FTDistribution2DCauchy(double coherence_length_x, double coherence_length_y, double gamma=0, double delta=Pi::PID2)
 
         """
         this = _libBornAgainCore.new_FTDistribution2DCauchy(*args)
@@ -9500,7 +9496,7 @@ class FTDistribution2DGauss(IFTDistribution2D):
         __init__(FTDistribution2DGauss self, double coherence_length_x, double coherence_length_y, double gamma=0) -> FTDistribution2DGauss
         __init__(FTDistribution2DGauss self, double coherence_length_x, double coherence_length_y) -> FTDistribution2DGauss
 
-        FTDistribution2DGauss::FTDistribution2DGauss(double coherence_length_x, double coherence_length_y, double gamma=0, double delta=Units::PID2)
+        FTDistribution2DGauss::FTDistribution2DGauss(double coherence_length_x, double coherence_length_y, double gamma=0, double delta=Pi::PID2)
 
         """
         this = _libBornAgainCore.new_FTDistribution2DGauss(*args)
@@ -9560,7 +9556,7 @@ class FTDistribution2DGate(IFTDistribution2D):
         __init__(FTDistribution2DGate self, double coherence_length_x, double coherence_length_y, double gamma=0) -> FTDistribution2DGate
         __init__(FTDistribution2DGate self, double coherence_length_x, double coherence_length_y) -> FTDistribution2DGate
 
-        FTDistribution2DGate::FTDistribution2DGate(double coherence_length_x, double coherence_length_y, double gamma=0, double delta=Units::PID2)
+        FTDistribution2DGate::FTDistribution2DGate(double coherence_length_x, double coherence_length_y, double gamma=0, double delta=Pi::PID2)
 
         """
         this = _libBornAgainCore.new_FTDistribution2DGate(*args)
@@ -9620,7 +9616,7 @@ class FTDistribution2DCone(IFTDistribution2D):
         __init__(FTDistribution2DCone self, double coherence_length_x, double coherence_length_y, double gamma=0) -> FTDistribution2DCone
         __init__(FTDistribution2DCone self, double coherence_length_x, double coherence_length_y) -> FTDistribution2DCone
 
-        FTDistribution2DCone::FTDistribution2DCone(double coherence_length_x, double coherence_length_y, double gamma=0, double delta=Units::PID2)
+        FTDistribution2DCone::FTDistribution2DCone(double coherence_length_x, double coherence_length_y, double gamma=0, double delta=Pi::PID2)
 
         """
         this = _libBornAgainCore.new_FTDistribution2DCone(*args)
@@ -9680,7 +9676,7 @@ class FTDistribution2DVoigt(IFTDistribution2D):
         __init__(FTDistribution2DVoigt self, double coherence_length_x, double coherence_length_y, double eta, double gamma=0) -> FTDistribution2DVoigt
         __init__(FTDistribution2DVoigt self, double coherence_length_x, double coherence_length_y, double eta) -> FTDistribution2DVoigt
 
-        FTDistribution2DVoigt::FTDistribution2DVoigt(double coherence_length_x, double coherence_length_y, double eta, double gamma=0, double delta=Units::PID2)
+        FTDistribution2DVoigt::FTDistribution2DVoigt(double coherence_length_x, double coherence_length_y, double eta, double gamma=0, double delta=Pi::PID2)
 
         """
         this = _libBornAgainCore.new_FTDistribution2DVoigt(*args)
diff --git a/auto/Wrap/libBornAgainCore_wrap.cpp b/auto/Wrap/libBornAgainCore_wrap.cpp
index a386b6810031a8cacdf8f99056b48ef28f6d74c7..8dd9f0b96762c763eb53f98551d2bb71b6426e67 100644
--- a/auto/Wrap/libBornAgainCore_wrap.cpp
+++ b/auto/Wrap/libBornAgainCore_wrap.cpp
@@ -27716,62 +27716,6 @@ fail:
 }
 
 
-SWIGINTERN int Swig_var_PI_set(PyObject *) {
-  SWIG_Error(SWIG_AttributeError,"Variable PI is read-only.");
-  return 1;
-}
-
-
-SWIGINTERN PyObject *Swig_var_PI_get(void) {
-  PyObject *pyobj = 0;
-  
-  pyobj = SWIG_From_double(static_cast< double >(Units::PI));
-  return pyobj;
-}
-
-
-SWIGINTERN int Swig_var_PID2_set(PyObject *) {
-  SWIG_Error(SWIG_AttributeError,"Variable PID2 is read-only.");
-  return 1;
-}
-
-
-SWIGINTERN PyObject *Swig_var_PID2_get(void) {
-  PyObject *pyobj = 0;
-  
-  pyobj = SWIG_From_double(static_cast< double >(Units::PID2));
-  return pyobj;
-}
-
-
-SWIGINTERN int Swig_var_PID4_set(PyObject *) {
-  SWIG_Error(SWIG_AttributeError,"Variable PID4 is read-only.");
-  return 1;
-}
-
-
-SWIGINTERN PyObject *Swig_var_PID4_get(void) {
-  PyObject *pyobj = 0;
-  
-  pyobj = SWIG_From_double(static_cast< double >(Units::PID4));
-  return pyobj;
-}
-
-
-SWIGINTERN int Swig_var_PI_SQR_set(PyObject *) {
-  SWIG_Error(SWIG_AttributeError,"Variable PI_SQR is read-only.");
-  return 1;
-}
-
-
-SWIGINTERN PyObject *Swig_var_PI_SQR_get(void) {
-  PyObject *pyobj = 0;
-  
-  pyobj = SWIG_From_double(static_cast< double >(Units::PI_SQR));
-  return pyobj;
-}
-
-
 SWIGINTERN int Swig_var_nanometer_set(PyObject *) {
   SWIG_Error(SWIG_AttributeError,"Variable nanometer is read-only.");
   return 1;
@@ -105141,7 +105085,7 @@ static PyMethodDef SwigMethods[] = {
 		"FTDecayFunction2DCauchy(double decay_length_x, double decay_length_y, double gamma=0)\n"
 		"new_FTDecayFunction2DCauchy(double decay_length_x, double decay_length_y) -> FTDecayFunction2DCauchy\n"
 		"\n"
-		"FTDecayFunction2DCauchy::FTDecayFunction2DCauchy(double decay_length_x, double decay_length_y, double gamma=0, double delta=Units::PID2)\n"
+		"FTDecayFunction2DCauchy::FTDecayFunction2DCauchy(double decay_length_x, double decay_length_y, double gamma=0, double delta=Pi::PID2)\n"
 		"\n"
 		""},
 	 { (char *)"delete_FTDecayFunction2DCauchy", _wrap_delete_FTDecayFunction2DCauchy, METH_VARARGS, (char *)"\n"
@@ -105170,7 +105114,7 @@ static PyMethodDef SwigMethods[] = {
 		"FTDecayFunction2DGauss(double decay_length_x, double decay_length_y, double gamma=0)\n"
 		"new_FTDecayFunction2DGauss(double decay_length_x, double decay_length_y) -> FTDecayFunction2DGauss\n"
 		"\n"
-		"FTDecayFunction2DGauss::FTDecayFunction2DGauss(double decay_length_x, double decay_length_y, double gamma=0, double delta=Units::PID2)\n"
+		"FTDecayFunction2DGauss::FTDecayFunction2DGauss(double decay_length_x, double decay_length_y, double gamma=0, double delta=Pi::PID2)\n"
 		"\n"
 		""},
 	 { (char *)"delete_FTDecayFunction2DGauss", _wrap_delete_FTDecayFunction2DGauss, METH_VARARGS, (char *)"\n"
@@ -105199,7 +105143,7 @@ static PyMethodDef SwigMethods[] = {
 		"FTDecayFunction2DVoigt(double decay_length_x, double decay_length_y, double eta, double gamma=0)\n"
 		"new_FTDecayFunction2DVoigt(double decay_length_x, double decay_length_y, double eta) -> FTDecayFunction2DVoigt\n"
 		"\n"
-		"FTDecayFunction2DVoigt::FTDecayFunction2DVoigt(double decay_length_x, double decay_length_y, double eta, double gamma=0, double delta=Units::PID2)\n"
+		"FTDecayFunction2DVoigt::FTDecayFunction2DVoigt(double decay_length_x, double decay_length_y, double eta, double gamma=0, double delta=Pi::PID2)\n"
 		"\n"
 		""},
 	 { (char *)"delete_FTDecayFunction2DVoigt", _wrap_delete_FTDecayFunction2DVoigt, METH_VARARGS, (char *)"\n"
@@ -105472,7 +105416,7 @@ static PyMethodDef SwigMethods[] = {
 		"FTDistribution2DCauchy(double coherence_length_x, double coherence_length_y, double gamma=0)\n"
 		"new_FTDistribution2DCauchy(double coherence_length_x, double coherence_length_y) -> FTDistribution2DCauchy\n"
 		"\n"
-		"FTDistribution2DCauchy::FTDistribution2DCauchy(double coherence_length_x, double coherence_length_y, double gamma=0, double delta=Units::PID2)\n"
+		"FTDistribution2DCauchy::FTDistribution2DCauchy(double coherence_length_x, double coherence_length_y, double gamma=0, double delta=Pi::PID2)\n"
 		"\n"
 		""},
 	 { (char *)"delete_FTDistribution2DCauchy", _wrap_delete_FTDistribution2DCauchy, METH_VARARGS, (char *)"\n"
@@ -105501,7 +105445,7 @@ static PyMethodDef SwigMethods[] = {
 		"FTDistribution2DGauss(double coherence_length_x, double coherence_length_y, double gamma=0)\n"
 		"new_FTDistribution2DGauss(double coherence_length_x, double coherence_length_y) -> FTDistribution2DGauss\n"
 		"\n"
-		"FTDistribution2DGauss::FTDistribution2DGauss(double coherence_length_x, double coherence_length_y, double gamma=0, double delta=Units::PID2)\n"
+		"FTDistribution2DGauss::FTDistribution2DGauss(double coherence_length_x, double coherence_length_y, double gamma=0, double delta=Pi::PID2)\n"
 		"\n"
 		""},
 	 { (char *)"delete_FTDistribution2DGauss", _wrap_delete_FTDistribution2DGauss, METH_VARARGS, (char *)"\n"
@@ -105530,7 +105474,7 @@ static PyMethodDef SwigMethods[] = {
 		"FTDistribution2DGate(double coherence_length_x, double coherence_length_y, double gamma=0)\n"
 		"new_FTDistribution2DGate(double coherence_length_x, double coherence_length_y) -> FTDistribution2DGate\n"
 		"\n"
-		"FTDistribution2DGate::FTDistribution2DGate(double coherence_length_x, double coherence_length_y, double gamma=0, double delta=Units::PID2)\n"
+		"FTDistribution2DGate::FTDistribution2DGate(double coherence_length_x, double coherence_length_y, double gamma=0, double delta=Pi::PID2)\n"
 		"\n"
 		""},
 	 { (char *)"delete_FTDistribution2DGate", _wrap_delete_FTDistribution2DGate, METH_VARARGS, (char *)"\n"
@@ -105559,7 +105503,7 @@ static PyMethodDef SwigMethods[] = {
 		"FTDistribution2DCone(double coherence_length_x, double coherence_length_y, double gamma=0)\n"
 		"new_FTDistribution2DCone(double coherence_length_x, double coherence_length_y) -> FTDistribution2DCone\n"
 		"\n"
-		"FTDistribution2DCone::FTDistribution2DCone(double coherence_length_x, double coherence_length_y, double gamma=0, double delta=Units::PID2)\n"
+		"FTDistribution2DCone::FTDistribution2DCone(double coherence_length_x, double coherence_length_y, double gamma=0, double delta=Pi::PID2)\n"
 		"\n"
 		""},
 	 { (char *)"delete_FTDistribution2DCone", _wrap_delete_FTDistribution2DCone, METH_VARARGS, (char *)"\n"
@@ -105588,7 +105532,7 @@ static PyMethodDef SwigMethods[] = {
 		"FTDistribution2DVoigt(double coherence_length_x, double coherence_length_y, double eta, double gamma=0)\n"
 		"new_FTDistribution2DVoigt(double coherence_length_x, double coherence_length_y, double eta) -> FTDistribution2DVoigt\n"
 		"\n"
-		"FTDistribution2DVoigt::FTDistribution2DVoigt(double coherence_length_x, double coherence_length_y, double eta, double gamma=0, double delta=Units::PID2)\n"
+		"FTDistribution2DVoigt::FTDistribution2DVoigt(double coherence_length_x, double coherence_length_y, double eta, double gamma=0, double delta=Pi::PID2)\n"
 		"\n"
 		""},
 	 { (char *)"delete_FTDistribution2DVoigt", _wrap_delete_FTDistribution2DVoigt, METH_VARARGS, (char *)"\n"
@@ -117644,10 +117588,6 @@ SWIG_init(void) {
   SWIG_addvarlink(SWIG_globals(),(char*)"minor_version_number",Swig_var_minor_version_number_get, Swig_var_minor_version_number_set);
   SWIG_addvarlink(SWIG_globals(),(char*)"patch_version_number",Swig_var_patch_version_number_get, Swig_var_patch_version_number_set);
   SWIG_addvarlink(SWIG_globals(),(char*)"PI2",Swig_var_PI2_get, Swig_var_PI2_set);
-  SWIG_addvarlink(SWIG_globals(),(char*)"PI",Swig_var_PI_get, Swig_var_PI_set);
-  SWIG_addvarlink(SWIG_globals(),(char*)"PID2",Swig_var_PID2_get, Swig_var_PID2_set);
-  SWIG_addvarlink(SWIG_globals(),(char*)"PID4",Swig_var_PID4_get, Swig_var_PID4_set);
-  SWIG_addvarlink(SWIG_globals(),(char*)"PI_SQR",Swig_var_PI_SQR_get, Swig_var_PI_SQR_set);
   SWIG_addvarlink(SWIG_globals(),(char*)"nanometer",Swig_var_nanometer_get, Swig_var_nanometer_set);
   SWIG_addvarlink(SWIG_globals(),(char*)"angstrom",Swig_var_angstrom_get, Swig_var_angstrom_set);
   SWIG_addvarlink(SWIG_globals(),(char*)"micrometer",Swig_var_micrometer_get, Swig_var_micrometer_set);
diff --git a/unused/ScanningMinimizer.h b/unused/ScanningMinimizer.h
index 4e27fbc270837b5c1edcd080c23428118951bc17..483bcfb4ce1a30476011771c93c121af4fbc04a6 100644
--- a/unused/ScanningMinimizer.h
+++ b/unused/ScanningMinimizer.h
@@ -3,7 +3,7 @@
 //  BornAgain: simulate and fit scattering at grazing incidence
 //
 //! @file      unused/ScanningMinimizer.h
-//! @brief     Declares class ScanningMinimizer.
+//! @brief     Defines class ScanningMinimizer.
 //!
 //! @homepage  http://www.bornagainproject.org
 //! @license   GNU General Public License v3 or higher (see COPYING)
@@ -16,7 +16,7 @@
 #ifndef MINIMIZERSCAN_H
 #define MINIMIZERSCAN_H
 
-#include "IMinimizer.h" // inheriting from
+#include "IMinimizer.h"
 #include "FitSuiteParameters.h"
 
 //! @class ScanningMinimizer