2 * This file is part of the GROMACS molecular simulation package.
4 * Copyright (c) 2010-2018, The GROMACS development team.
5 * Copyright (c) 2019,2020, by the GROMACS development team, led by
6 * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
7 * and including many others, as listed in the AUTHORS file in the
8 * top-level source directory and at http://www.gromacs.org.
10 * GROMACS is free software; you can redistribute it and/or
11 * modify it under the terms of the GNU Lesser General Public License
12 * as published by the Free Software Foundation; either version 2.1
13 * of the License, or (at your option) any later version.
15 * GROMACS is distributed in the hope that it will be useful,
16 * but WITHOUT ANY WARRANTY; without even the implied warranty of
17 * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU
18 * Lesser General Public License for more details.
20 * You should have received a copy of the GNU Lesser General Public
21 * License along with GROMACS; if not, see
22 * http://www.gnu.org/licenses, or write to the Free Software Foundation,
23 * Inc., 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA.
25 * If you want to redistribute modifications to GROMACS, please
26 * consider that scientific software is very special. Version
27 * control is crucial - bugs must be traceable. We will be happy to
28 * consider code for inclusion in the official distribution, but
29 * derived work must not be called official GROMACS. Details are found
30 * in the README & COPYING files - if they are missing, get the
31 * official version at http://www.gromacs.org.
33 * To help us fund GROMACS development, we humbly ask that you cite
34 * the research papers on the package. Check out http://www.gromacs.org.
38 * Implements classes in plot.h.
40 * \ingroup module_analysisdata
41 * \author Teemu Murtola <teemu.murtola@gmail.com>
53 #include "gromacs/analysisdata/dataframe.h"
54 #include "gromacs/fileio/gmxfio.h"
55 #include "gromacs/fileio/oenv.h"
56 #include "gromacs/fileio/xvgr.h"
57 #include "gromacs/math/vec.h"
58 #include "gromacs/options/basicoptions.h"
59 #include "gromacs/options/ioptionscontainer.h"
60 #include "gromacs/options/timeunitmanager.h"
61 #include "gromacs/selection/selectioncollection.h"
62 #include "gromacs/utility/exceptions.h"
63 #include "gromacs/utility/gmxassert.h"
64 #include "gromacs/utility/programcontext.h"
65 #include "gromacs/utility/stringutil.h"
66 #include "gromacs/utility/unique_cptr.h"
71 /********************************************************************
72 * AnalysisDataPlotSettings
75 AnalysisDataPlotSettings::AnalysisDataPlotSettings() :
77 timeUnit_(TimeUnit::Default
),
78 plotFormat_(XvgFormat::Xmgrace
)
82 void AnalysisDataPlotSettings::setSelectionCollection(const SelectionCollection
* selections
)
84 selections_
= selections
;
87 /*! \brief Names for XvgFormat
89 * Technically this duplicates a definition in pargs.cpp for legacy
90 * support code, but as the latter will go away and the alternatives
91 * are ugly, the duplication is acceptable. */
92 const gmx::EnumerationArray
<XvgFormat
, const char*> c_xvgFormatNames
= { { "xmgrace", "xmgr",
95 void AnalysisDataPlotSettings::initOptions(IOptionsContainer
* options
)
98 EnumOption
<XvgFormat
>("xvg").enumValue(c_xvgFormatNames
).store(&plotFormat_
).description("Plot formatting"));
102 /********************************************************************
103 * AbstractPlotModule::Impl
106 class AbstractPlotModule::Impl
109 explicit Impl(const AnalysisDataPlotSettings
& settings
);
114 AnalysisDataPlotSettings settings_
;
115 std::string filename_
;
120 bool bErrorsAsSeparateColumn_
;
122 std::string subtitle_
;
125 std::vector
<std::string
> legend_
;
126 std::string xformat_
;
127 std::string yformat_
;
131 AbstractPlotModule::Impl::Impl(const AnalysisDataPlotSettings
& settings
) :
136 bErrorsAsSeparateColumn_(false),
143 AbstractPlotModule::Impl::~Impl()
149 void AbstractPlotModule::Impl::closeFile()
166 /********************************************************************
170 AbstractPlotModule::AbstractPlotModule() : impl_(new Impl(AnalysisDataPlotSettings())) {}
172 AbstractPlotModule::AbstractPlotModule(const AnalysisDataPlotSettings
& settings
) :
173 impl_(new Impl(settings
))
178 AbstractPlotModule::~AbstractPlotModule() {}
181 void AbstractPlotModule::setSettings(const AnalysisDataPlotSettings
& settings
)
183 impl_
->settings_
= settings
;
187 void AbstractPlotModule::setFileName(const std::string
& filename
)
189 impl_
->filename_
= filename
;
193 void AbstractPlotModule::setPlainOutput(bool bPlain
)
195 impl_
->bPlain_
= bPlain
;
199 void AbstractPlotModule::setErrorsAsSeparateColumn(bool bSeparate
)
201 impl_
->bErrorsAsSeparateColumn_
= bSeparate
;
205 void AbstractPlotModule::setOmitX(bool bOmitX
)
207 impl_
->bOmitX_
= bOmitX
;
211 void AbstractPlotModule::setTitle(const char* title
)
213 impl_
->title_
= title
;
216 void AbstractPlotModule::setTitle(const std::string
& title
)
218 impl_
->title_
= title
;
222 void AbstractPlotModule::setSubtitle(const char* subtitle
)
224 impl_
->subtitle_
= subtitle
;
228 void AbstractPlotModule::setSubtitle(const std::string
& subtitle
)
230 impl_
->subtitle_
= subtitle
;
234 void AbstractPlotModule::setXLabel(const char* label
)
236 impl_
->xlabel_
= label
;
240 void AbstractPlotModule::setXAxisIsTime()
242 TimeUnitManager
manager(impl_
->settings_
.timeUnit());
243 impl_
->xlabel_
= formatString("Time (%s)", manager
.timeUnitAsString());
244 impl_
->xscale_
= manager
.inverseTimeScaleFactor();
248 void AbstractPlotModule::setYLabel(const char* label
)
250 impl_
->ylabel_
= label
;
254 void AbstractPlotModule::setLegend(int nsets
, const char* const* setname
)
256 impl_
->legend_
.reserve(impl_
->legend_
.size() + nsets
);
257 for (int i
= 0; i
< nsets
; ++i
)
259 appendLegend(setname
[i
]);
264 void AbstractPlotModule::appendLegend(const char* setname
)
266 impl_
->legend_
.emplace_back(setname
);
270 void AbstractPlotModule::appendLegend(const std::string
& setname
)
272 impl_
->legend_
.push_back(setname
);
276 void AbstractPlotModule::setXFormat(int width
, int precision
, char format
)
278 GMX_RELEASE_ASSERT(width
>= 0 && precision
>= 0 && width
<= 99 && precision
<= 99,
279 "Invalid width or precision");
280 GMX_RELEASE_ASSERT(strchr("eEfFgG", format
) != nullptr, "Invalid format specifier");
281 impl_
->xformat_
= formatString("%%%d.%d%c", width
, precision
, format
);
285 void AbstractPlotModule::setYFormat(int width
, int precision
, char format
)
287 GMX_RELEASE_ASSERT(width
>= 0 && precision
>= 0 && width
<= 99 && precision
<= 99,
288 "Invalid width or precision");
289 GMX_RELEASE_ASSERT(strchr("eEfFgG", format
) != nullptr, "Invalid format specifier");
290 impl_
->yformat_
= formatString(" %%%d.%d%c", width
, precision
, format
);
294 int AbstractPlotModule::flags() const
296 return efAllowMissing
| efAllowMulticolumn
| efAllowMultipoint
| efAllowMultipleDataSets
;
300 void AbstractPlotModule::dataStarted(AbstractAnalysisData
* /* data */)
302 if (!impl_
->filename_
.empty())
306 impl_
->fp_
= gmx_fio_fopen(impl_
->filename_
.c_str(), "w");
310 const TimeUnit timeUnit
= impl_
->settings_
.timeUnit();
311 const XvgFormat xvgFormat
= impl_
->settings_
.plotFormat();
312 gmx_output_env_t
* oenv
;
313 output_env_init(&oenv
, getProgramContext(), timeUnit
, FALSE
, xvgFormat
, 0);
314 const unique_cptr
<gmx_output_env_t
, output_env_done
> oenvGuard(oenv
);
315 impl_
->fp_
= xvgropen(impl_
->filename_
.c_str(), impl_
->title_
.c_str(), impl_
->xlabel_
,
316 impl_
->ylabel_
, oenv
);
317 const SelectionCollection
* selections
= impl_
->settings_
.selectionCollection();
318 if (selections
!= nullptr && output_env_get_xvg_format(oenv
) != XvgFormat::None
)
320 selections
->printXvgrInfo(impl_
->fp_
);
322 if (!impl_
->subtitle_
.empty())
324 xvgr_subtitle(impl_
->fp_
, impl_
->subtitle_
.c_str(), oenv
);
326 if (output_env_get_print_xvgr_codes(oenv
) && !impl_
->legend_
.empty())
328 std::vector
<const char*> legend
;
329 legend
.reserve(impl_
->legend_
.size());
330 for (size_t i
= 0; i
< impl_
->legend_
.size(); ++i
)
332 legend
.push_back(impl_
->legend_
[i
].c_str());
334 xvgr_legend(impl_
->fp_
, legend
.size(), legend
.data(), oenv
);
341 void AbstractPlotModule::frameStarted(const AnalysisDataFrameHeader
& header
)
349 std::fprintf(impl_
->fp_
, impl_
->xformat_
.c_str(), header
.x() * impl_
->xscale_
);
354 void AbstractPlotModule::frameFinished(const AnalysisDataFrameHeader
& /*header*/)
360 std::fprintf(impl_
->fp_
, "\n");
364 void AbstractPlotModule::dataFinished()
370 bool AbstractPlotModule::isFileOpen() const
372 return impl_
->fp_
!= nullptr;
376 void AbstractPlotModule::writeValue(const AnalysisDataValue
& value
) const
378 GMX_ASSERT(isFileOpen(), "File not opened, but write attempted");
379 const real y
= value
.isSet() ? value
.value() : 0.0;
380 std::fprintf(impl_
->fp_
, impl_
->yformat_
.c_str(), y
);
381 if (impl_
->bErrorsAsSeparateColumn_
)
383 const real dy
= value
.isSet() ? value
.error() : 0.0;
384 std::fprintf(impl_
->fp_
, impl_
->yformat_
.c_str(), dy
);
389 /********************************************************************
393 AnalysisDataPlotModule::AnalysisDataPlotModule() {}
395 AnalysisDataPlotModule::AnalysisDataPlotModule(const AnalysisDataPlotSettings
& settings
) :
396 AbstractPlotModule(settings
)
401 void AnalysisDataPlotModule::pointsAdded(const AnalysisDataPointSetRef
& points
)
407 for (int i
= 0; i
< points
.columnCount(); ++i
)
409 writeValue(points
.values()[i
]);
414 /********************************************************************
415 * DataVectorPlotModule
418 AnalysisDataVectorPlotModule::AnalysisDataVectorPlotModule() : bWrite_
{ true, true, true, false } {}
421 AnalysisDataVectorPlotModule::AnalysisDataVectorPlotModule(const AnalysisDataPlotSettings
& settings
) :
422 AbstractPlotModule(settings
),
423 bWrite_
{ true, true, true, false }
428 void AnalysisDataVectorPlotModule::setWriteX(bool bWrite
)
430 bWrite_
[XX
] = bWrite
;
434 void AnalysisDataVectorPlotModule::setWriteY(bool bWrite
)
436 bWrite_
[YY
] = bWrite
;
440 void AnalysisDataVectorPlotModule::setWriteZ(bool bWrite
)
442 bWrite_
[ZZ
] = bWrite
;
446 void AnalysisDataVectorPlotModule::setWriteNorm(bool bWrite
)
448 bWrite_
[DIM
] = bWrite
;
452 void AnalysisDataVectorPlotModule::setWriteMask(const bool bWrite
[DIM
+ 1])
454 for (int i
= 0; i
< DIM
+ 1; ++i
)
456 bWrite_
[i
] = bWrite
[i
];
461 void AnalysisDataVectorPlotModule::pointsAdded(const AnalysisDataPointSetRef
& points
)
463 if (points
.firstColumn() % DIM
!= 0 || points
.columnCount() % DIM
!= 0)
465 GMX_THROW(APIError("Partial data points"));
471 for (int i
= 0; i
< points
.columnCount(); i
+= 3)
473 for (int d
= 0; d
< DIM
; ++d
)
477 writeValue(points
.values()[i
+ d
]);
482 const rvec y
= { points
.y(i
), points
.y(i
+ 1), points
.y(i
+ 2) };
483 AnalysisDataValue
value(norm(y
));