Sort all includes in src/gromacs
[alexxy/gromacs.git] / src / gromacs / options / abstractoption.h
index 2c165a9f8e207d2423738aae76ccd8b5af2816dc..2793f2f0faa3e19a5fd99cc73b6937bbbab2a5da 100644 (file)
@@ -1,36 +1,40 @@
 /*
+ * This file is part of the GROMACS molecular simulation package.
  *
- *                This source code is part of
+ * Copyright (c) 2010,2011,2012,2013,2014, by the GROMACS development team, led by
+ * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
+ * and including many others, as listed in the AUTHORS file in the
+ * top-level source directory and at http://www.gromacs.org.
  *
- *                 G   R   O   M   A   C   S
+ * GROMACS is free software; you can redistribute it and/or
+ * modify it under the terms of the GNU Lesser General Public License
+ * as published by the Free Software Foundation; either version 2.1
+ * of the License, or (at your option) any later version.
  *
- *          GROningen MAchine for Chemical Simulations
+ * GROMACS is distributed in the hope that it will be useful,
+ * but WITHOUT ANY WARRANTY; without even the implied warranty of
+ * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE.  See the GNU
+ * Lesser General Public License for more details.
  *
- * Written by David van der Spoel, Erik Lindahl, Berk Hess, and others.
- * Copyright (c) 1991-2000, University of Groningen, The Netherlands.
- * Copyright (c) 2001-2009, The GROMACS development team,
- * check out http://www.gromacs.org for more information.
-
- * This program is free software; you can redistribute it and/or
- * modify it under the terms of the GNU General Public License
- * as published by the Free Software Foundation; either version 2
- * of the License, or (at your option) any later version.
+ * You should have received a copy of the GNU Lesser General Public
+ * License along with GROMACS; if not, see
+ * http://www.gnu.org/licenses, or write to the Free Software Foundation,
+ * Inc., 51 Franklin Street, Fifth Floor, Boston, MA  02110-1301  USA.
  *
- * If you want to redistribute modifications, please consider that
- * scientific software is very special. Version control is crucial -
- * bugs must be traceable. We will be happy to consider code for
- * inclusion in the official distribution, but derived work must not
- * be called official GROMACS. Details are found in the README & COPYING
- * files - if they are missing, get the official version at www.gromacs.org.
+ * If you want to redistribute modifications to GROMACS, please
+ * consider that scientific software is very special. Version
+ * control is crucial - bugs must be traceable. We will be happy to
+ * consider code for inclusion in the official distribution, but
+ * derived work must not be called official GROMACS. Details are found
+ * in the README & COPYING files - if they are missing, get the
+ * official version at http://www.gromacs.org.
  *
  * To help us fund GROMACS development, we humbly ask that you cite
- * the papers on the package - you can find them in the top README file.
- *
- * For more info, check our website at http://www.gromacs.org
+ * the research papers on the package. Check out http://www.gromacs.org.
  */
 /*! \file
  * \brief
- * Defines gmx::AbstractOption and a related template.
+ * Defines gmx::AbstractOption, gmx::OptionTemplate and gmx::OptionInfo.
  *
  * This header defines base classes for option settings that are used with
  * Options::addOption().  These classes implement the "named parameter"
@@ -43,7 +47,7 @@
  * but methods of OptionTemplate are visible even to the normal user through
  * its subclasses.
  *
- * \author Teemu Murtola <teemu.murtola@cbr.su.se>
+ * \author Teemu Murtola <teemu.murtola@gmail.com>
  * \inlibraryapi
  * \ingroup module_options
  */
 #include <string>
 #include <vector>
 
-#include "../utility/uniqueptr.h"
-
-#include "optionflags.h"
+#include "gromacs/options/optionflags.h"
+#include "gromacs/utility/common.h"
 
 namespace gmx
 {
 
 class AbstractOptionStorage;
 template <typename T> class OptionStorageTemplate;
+class OptionManagerContainer;
 class Options;
 
-//! Smart pointer for managing an AbstractOptionStorage object.
-typedef gmx_unique_ptr<AbstractOptionStorage>::type
-        AbstractOptionStoragePointer;
-
 /*! \brief
  * Abstract base class for specifying option properties.
  *
@@ -79,7 +79,10 @@ typedef gmx_unique_ptr<AbstractOptionStorage>::type
  * point when the actual option is created.
  *
  * Subclasses should override createStorage() to create the correct type
- * of storage object.
+ * of storage object.  If they use their own info type derived from OptionInfo,
+ * they should also have a public typedef \c InfoType that specifies that
+ * info type.  This is required for Options::addOption() to return the correct
+ * info type.
  *
  * \ingroup module_options
  */
@@ -100,8 +103,10 @@ class AbstractOption
         /*! \brief
          * Creates a default storage object for the option.
          *
-         * \returns The created storage object.
-         * \throws  APIError if invalid option settings have been provided.
+         * \param[in] managers  Manager container (unused if the option does
+         *     not use a manager).
+         * \returns   The created storage object.
+         * \throws    APIError if invalid option settings have been provided.
          *
          * This method is called by Options::addOption() when initializing an
          * option from the settings.
@@ -111,22 +116,16 @@ class AbstractOption
          * They should also throw APIError if they detect problems.
          *
          * Should only be called by Options::addOption().
-         */
-        virtual AbstractOptionStoragePointer createStorage() const = 0;
-
-        /*! \brief
-         * Creates the description string for the option.
-         *
-         * \returns Description string for the option.
          *
-         * This function is virtual to allow derived classes to customize the
-         * description programmatically, e.g., by adding the list of allowed
-         * values.
-         * The default implementation simply returns the user-provided
-         * description.
+         * The ownership of the return value is passed, but is not using a
+         * smart pointer to avoid introducing such a dependency in an installed
+         * header.  The implementation will always consist of a single `new`
+         * call and returning that value, and the caller always immediately
+         * wraps the pointer in a smart pointer, so there is not exception
+         * safety issue.
          */
-        virtual std::string createDescription() const
-        { return descr_ ? descr_ : ""; }
+        virtual AbstractOptionStorage *createStorage(
+            const OptionManagerContainer &managers) const = 0;
 
         //! Sets the description for the option.
         void setDescription(const char *descr) { descr_ = descr; }
@@ -137,11 +136,24 @@ class AbstractOption
         //! Sets or clears a flag for the option.
         void setFlag(OptionFlag flag, bool bSet) { flags_.set(flag, bSet); }
         //! Returns true if the option is vector-valued.
-        bool isVector() const { return hasFlag(efVector); }
-        //! Sets the option to be vector-valued.
+        bool isVector() const { return hasFlag(efOption_Vector); }
+        /*! \brief
+         * Sets the option to be vector-valued.
+         *
+         * This method is provided for convenience to make management of value
+         * counts easier.  In order to implement a vector-valued option, the
+         * class derived from AbstractOption should expose a method that calls
+         * this method, and the storage object derived from
+         * AbstractOptionStorage should check isVector().
+         * If only a single value is provided, the storage object should fill
+         * the whole vector with that value.
+         *
+         * The length of the vector (the value of maxValueCount_) must be
+         * fixed.  The default length is 3 elements.
+         */
         void setVector()
         {
-            setFlag(efVector);
+            setFlag(efOption_Vector);
             minValueCount_ = 1;
             if (maxValueCount_ == 1)
             {
@@ -151,7 +163,7 @@ class AbstractOption
         //! Sets the required number of values for the option.
         void setValueCount(int count)
         {
-            if (!hasFlag(efVector))
+            if (!hasFlag(efOption_Vector))
             {
                 minValueCount_ = count;
             }
@@ -192,8 +204,8 @@ class AbstractOption
  *
  * This template is used as a base class like this:
  * \code
-class ConcreteOption : public OptionTemplate<int, ConcreteOption>
-{
+   class ConcreteOption : public OptionTemplate<int, ConcreteOption>
+   {
  * \endcode
  *
  * All public functions in this class return \c *this casted to a reference to
@@ -225,17 +237,24 @@ class OptionTemplate : public AbstractOption
         { setDescription(descr); return me(); }
         //! Hides the option from normal help output.
         MyClass &hidden(bool bHidden = true)
-        { setFlag(efHidden, bHidden); return me(); }
-        //! Requires the option to be specified explicitly.
+        { setFlag(efOption_Hidden, bHidden); return me(); }
+        /*! \brief
+         * Requires the option to be specified explicitly.
+         *
+         * Note that if you specify defaultValue() together with required(),
+         * the user is not required to explicitly provide the option.
+         * In this case, required() only affects possible help output.
+         */
         MyClass &required(bool bRequired = true)
-        { setFlag(efRequired, bRequired); return me(); }
+        { setFlag(efOption_Required, bRequired); return me(); }
         //! Allows the option to be specified multiple times.
         MyClass &allowMultiple(bool bMulti = true)
-        { setFlag(efMulti, bMulti); return me(); }
+        { setFlag(efOption_MultipleTimes, bMulti); return me(); }
         //! Requires exactly \p count values for the option.
         MyClass &valueCount(int count) { setValueCount(count); return me(); }
         //! Allows any number of values for the option.
-        MyClass &multiValue() { maxValueCount_ = -1; return me(); }
+        MyClass &multiValue(bool bMulti = true)
+        { if (bMulti) { maxValueCount_ = -1; } return me(); }
 
         /*! \brief
          * Sets a default value for the option.
@@ -247,8 +266,6 @@ class OptionTemplate : public AbstractOption
          * is no default value, the storage is not altered, which can also be
          * used to provide a default value.  The latter method has to be used
          * if the option can take multiple values.
-         * If required() is specified, only affects the default value shown in
-         * help output.
          *
          * \p defaultValue is copied when the option is created.
          */
@@ -284,7 +301,7 @@ class OptionTemplate : public AbstractOption
          * Options object exists.
          */
         MyClass &store(T *store)
-        { setFlag(efExternalStore); store_ = store; return me(); }
+        { store_ = store; return me(); }
         /*! \brief
          * Stores number of values in the value pointed by \p countptr.
          *
@@ -312,7 +329,7 @@ class OptionTemplate : public AbstractOption
          * Options object exists.
          */
         MyClass &storeVector(std::vector<T> *store)
-        { setFlag(efExternalValueVector); storeVector_ = store; return me(); }
+        { storeVector_ = store; return me(); }
 
     protected:
         /*! \cond libapi */
@@ -354,6 +371,126 @@ class OptionTemplate : public AbstractOption
         friend class OptionStorageTemplate<T>;
 };
 
+/*! \brief
+ * Gives information and allows modifications to an option after creation.
+ *
+ * When an option is added with Options::addOption(), an object of a subclass
+ * of OptionInfo is returned.  This object can be later used to access
+ * information about the option.  Non-const methods also allow later changing
+ * (some of) the option settings provided at initialization time.
+ * The properties accessible/modifiable through this interface are implemented
+ * based on need, and may not be implemented for all cases.
+ *
+ * \if libapi
+ * This class is also used by OptionsVisitor and OptionsModifyingVisitor as
+ * the interface that allows querying/modifying each visited option.
+ * \endif
+ *
+ * This class isolates the details of the internal option implementation from
+ * callers.  Although this class is a simple reference to the underlying
+ * implementation, it is implemented as non-copyable to allow const/non-const
+ * status of a reference to this class to indicate whether modifications are
+ * allowed.  Otherwise, separate classes would be needed for access and
+ * modification, complicating the implementation.  In the implementation,
+ * there is always a single OptionInfo instance referring to one option.
+ * The underlying implementation object always owns this instance, and only
+ * references are passed to callers.
+ *
+ * \see Options::addOption()
+ * \if libapi
+ * \see OptionsVisitor
+ * \see OptionsModifyingVisitor
+ * \endif
+ *
+ * \inpublicapi
+ * \ingroup module_options
+ */
+class OptionInfo
+{
+    public:
+        virtual ~OptionInfo();
+
+        /*! \brief
+         * Test whether the option is of a particular type.
+         *
+         * \tparam InfoType  Option type to test for. Should be a class derived
+         *      from OptionInfo.
+         */
+        template <class InfoType>
+        bool isType() const
+        {
+            return toType<InfoType>() != NULL;
+        }
+        /*! \brief
+         * Convert the info object to a particular type if the type is correct.
+         *
+         * \tparam InfoType  Option type to convert to. Should be a class
+         *      derived from OptionInfo.
+         * \retval this converted to a pointer to \p InfoType, or NULL if the
+         *      conversion is not possible.
+         */
+        template <class InfoType>
+        InfoType *toType()
+        {
+            return dynamic_cast<InfoType *>(this);
+        }
+        //! \copydoc toType()
+        template <class InfoType>
+        const InfoType *toType() const
+        {
+            return dynamic_cast<const InfoType *>(this);
+        }
+
+        //! Returns true if the option has been set.
+        bool isSet() const;
+        //! Returns true if the option is a hidden option.
+        bool isHidden() const;
+        //! Returns true if the option is required.
+        bool isRequired() const;
+        //! Returns the minimum number of values that this option accepts.
+        int minValueCount() const;
+        //! Returns the maximum number of values that this option accepts.
+        int maxValueCount() const;
+        //! Returns the name of the option.
+        const std::string &name() const;
+        //! Returns the type of the option as a string.
+        std::string type() const;
+        //! Returns the description of the option.
+        std::string formatDescription() const;
+        /*! \brief
+         * Returns the default value if set for the option as a string.
+         *
+         * \see OptionTemplate::defaultValueIfSet()
+         */
+        std::string formatDefaultValueIfSet() const;
+
+        //! Returns the number of values given for the option.
+        int valueCount() const;
+        //! Returns the i'th value of the option as a string.
+        std::string formatValue(int i) const;
+
+    protected:
+        /*! \cond libapi */
+        /*! \brief
+         * Wraps a given option object.
+         *
+         * Does not throw.
+         */
+        explicit OptionInfo(AbstractOptionStorage *option);
+
+        //! Returns the wrapped option storage object.
+        AbstractOptionStorage       &option() { return option_; }
+        //! Returns the wrapped option storage object.
+        const AbstractOptionStorage &option() const { return option_; }
+        //! \endcond
+
+    private:
+        //! The wrapped option.
+        AbstractOptionStorage  &option_;
+
+        GMX_DISALLOW_COPY_AND_ASSIGN(OptionInfo);
+};
+
 } // namespace gmx
 
 #endif