10 #include "Teuchos_StackedTimer.hpp"
23 level_(std::numeric_limits<unsigned>::max()),name_(
"INVALID"),parent_(nullptr)
34 for (
unsigned i=0; i<level_; ++i)
36 os << name_<<
":"<<
accumulatedTime()<<
" [" << count_started_<<
"] ("<< count_updates_ <<
")"<<std::endl;
38 for (
size_t i=0; i<sub_timers_.size(); ++i) {
39 t_total += sub_timers_[i].accumulatedTime();
40 sub_timers_[i].report(os);
42 if ( sub_timers_.size() == 0 )
44 for (
unsigned i=0; i<=level_; ++i)
53 if (get_full_name() == name) {
57 for (
unsigned i=0;i<sub_timers_.size(); ++i){
58 t = sub_timers_[i].findBaseTimer(name);
68 BaseTimer::TimeInfo t;
69 auto full_name = get_full_name();
70 if (full_name.size() > name.size())
72 if ( strncmp(full_name.c_str(), name.c_str(), full_name.size()))
74 if (get_full_name() == name) {
75 t = BaseTimer::TimeInfo(
this);
79 for (
unsigned i=0;i<sub_timers_.size(); ++i){
80 t = sub_timers_[i].findTimer(name,found);
91 flat_names_.
resize(num_timers);
93 timer_.addTimerNames(flat_names_, pos);
100 flat_names_ = all_names;
106 int num_names = flat_names_.
size();
109 updates_.
resize(num_names);
110 active_.
resize(num_names);
112 if (options.output_minmax || options.output_histogram || options.output_proc_minmax) {
115 if ( options.output_minmax )
116 sum_sq_.
resize(num_names);
125 if (options.output_proc_minmax) {
126 procmin_.
resize(num_names);
127 procmax_.
resize(num_names);
131 if (options.output_histogram ) {
132 hist_.resize(options.num_histogram);
133 for (
int i=0;i<options.num_histogram ; ++i)
134 hist_[i].resize(num_names);
141 if (options.output_total_updates)
142 updates.
resize(num_names);
146 if (options.output_histogram)
150 for (
int i=0;i<num_names; ++i) {
155 used[i] = t.count==0? 0:1;
156 if (options.output_total_updates)
157 updates[i] = t.updates;
167 for (
int i=0;i<num_names;++i)
171 for (
int i=0;i<num_names;++i)
174 if (procmin_.
size()) {
177 int commRank = comm->getRank();
178 for (
int i=0;i<num_names; ++i) {
179 if (used[i] && (min_[i]==time[i]))
180 procmin[i] = commRank;
183 if (used[i] && (max_[i]==time[i]))
184 procmax[i] = commRank;
193 if (options.output_histogram) {
194 for (
int i=0;i<num_names; ++i) {
196 double dh = (max_[i]-min_[i])/options.num_histogram;
200 int bin=(time[i]- min_[i])/dh;
201 bins[i] = std::max(std::min(bin,options.num_histogram-1) , 0);
206 for (
int j=0; j<options.num_histogram; ++j){
207 for (
int i=0;i<num_names; ++i) {
217 if (sum_sq_.
size()) {
218 for (
int i=0;i<num_names; ++i)
225 std::pair<std::string, std::string> getPrefix(
const std::string &name) {
226 for (std::size_t i=name.size()-1; i>0; --i)
227 if (name[i] ==
'@') {
228 return std::pair<std::string, std::string>(name.substr(0,i), name.substr(i+1));
230 return std::pair<std::string, std::string>(std::string(
""), name);
236 std::vector<bool> &printed,
242 double total_time = 0.0;
244 for (
int i=0; i<flat_names_.
size(); ++i ) {
245 if (sum_[i]/active_[i] <= options.drop_time)
249 int level = std::count(flat_names_[i].begin(), flat_names_[i].end(),
'@');
250 if ( (level != print_level) || (level >= options.max_levels) )
252 auto split_names = getPrefix(flat_names_[i]);
253 if ( prefix != split_names.first)
258 std::ostringstream os;
259 for (
int l=0; l<level; ++l)
262 os << split_names.second <<
": ";
263 alignments_.timer_names_= std::max(alignments_.timer_names_,os.str().size());
268 std::ostringstream os;
269 os << sum_[i]/active_[i];
270 alignments_.average_time_ = std::max(alignments_.average_time_,os.str().size());
274 if ( options.output_fraction && parent_time>0) {
275 std::ostringstream os;
276 os <<
" - "<<sum_[i]/active_[i]/parent_time*100<<
"%";
277 alignments_.fraction_ = std::max(alignments_.fraction_,os.str().size());
282 std::ostringstream os;
283 os <<
" ["<<count_[i]/active_[i]<<
"]";
284 alignments_.count_ = std::max(alignments_.count_,os.str().size());
288 if ( options.output_total_updates) {
289 std::ostringstream os;
290 os <<
" ("<<updates_[i]/active_[i]<<
")";
291 alignments_.total_updates_ = std::max(alignments_.total_updates_,os.str().size());
295 if ( options.output_minmax && active_[i]>1) {
297 std::ostringstream os;
298 os <<
" {min=" << min_[i];
299 alignments_.min_ = std::max(alignments_.min_,os.str().size());
302 std::ostringstream os;
303 os <<
", max=" << max_[i];
306 alignments_.max_ = std::max(alignments_.max_,os.str().size());
308 if (procmin_.
size()) {
309 std::ostringstream os;
310 os <<
", proc min=" << procmin_[i];
313 alignments_.procmin_ = std::min(alignments_.procmin_,os.str().size());
315 if (procmax_.
size()) {
316 std::ostringstream os;
317 os <<
", proc max=" << procmax_[i];
320 alignments_.procmax_ = std::max(alignments_.procmax_,os.str().size());
323 std::ostringstream os;
324 os <<
", std dev=" << sqrt(std::max<double>(sum_sq_[i]-sum_[i]*sum_[i]/active_[i],0.0)/(active_[i]-1));
326 alignments_.stddev_ = std::max(alignments_.stddev_,os.str().size());
330 if ( options.output_histogram && active_[i] >1 ) {
331 std::ostringstream os;
333 for (
int h=0;h<options.num_histogram; ++h) {
335 os <<
", "<<hist_[h][i];
340 alignments_.histogram_ = std::max(alignments_.histogram_,os.str().size());
348 if (options.print_names_before_values) {
349 std::ostringstream tmp;
350 for (
int l=0; l<=level; ++l)
352 tmp <<
"Remainder: ";
353 alignments_.timer_names_ = std::max(alignments_.timer_names_,tmp.str().size());
356 std::ostringstream tmp;
357 tmp << sum_[i]/active_[i]- sub_time;
358 alignments_.average_time_ = std::max(alignments_.average_time_,tmp.str().size());
360 if ( options.output_fraction && (sum_[i]/active_[i] > 0.) ) {
361 std::ostringstream tmp;
362 tmp <<
" - "<< (sum_[i]/active_[i]- sub_time)/(sum_[i]/active_[i])*100 <<
"%";
363 alignments_.fraction_ = std::max(alignments_.fraction_,tmp.str().size());
367 total_time += sum_[i]/active_[i];
380 double total_time = 0.0;
382 for (
int i=0; i<flat_names_.
size(); ++i ) {
383 if (sum_[i]/active_[i] <= options.drop_time) {
388 int level = std::count(flat_names_[i].begin(), flat_names_[i].end(),
'@');
389 if ( (level != print_level) || (level >= options.max_levels) )
391 auto split_names = getPrefix(flat_names_[i]);
392 if ( prefix != split_names.first)
396 if (options.print_names_before_values) {
397 std::ostringstream tmp;
398 for (
int l=0; l<level; ++l) {
402 tmp << split_names.second <<
": ";
403 if (options.align_columns)
404 os << std::left << std::setw(alignments_.timer_names_);
409 std::ostringstream tmp;
410 tmp << sum_[i]/active_[i];
411 if (options.align_columns)
412 os << std::left << std::setw(alignments_.average_time_);
416 if ( options.output_fraction && parent_time>0) {
417 std::ostringstream tmp;
418 tmp <<
" - "<<sum_[i]/active_[i]/parent_time*100<<
"%";
419 if (options.align_columns)
420 os << std::left << std::setw(alignments_.fraction_);
424 else if (options.output_fraction) {
425 if (options.align_columns)
426 os << std::setw(alignments_.fraction_) <<
" ";
430 std::ostringstream tmp;
431 tmp <<
" ["<<count_[i]/active_[i]<<
"]";
432 if (options.align_columns)
433 os << std::left << std::setw(alignments_.count_);
437 if ( options.output_total_updates ) {
438 std::ostringstream tmp;
439 tmp <<
" ("<<updates_[i]/active_[i]<<
")";
440 if (options.align_columns)
441 os << std::left << std::setw(alignments_.total_updates_);
445 if ( options.output_minmax && active_[i]>1) {
447 std::ostringstream tmp;
448 tmp <<
" {min="<<min_[i];
449 if (options.align_columns)
450 os << std::left << std::setw(alignments_.min_);
454 std::ostringstream tmp;
455 tmp <<
", max="<<max_[i];
458 if (options.align_columns)
459 os << std::left << std::setw(alignments_.max_);
462 if (procmin_.
size()) {
463 std::ostringstream tmp;
464 tmp <<
", proc min="<<procmin_[i];
467 if (options.align_columns)
468 os << std::left << std::setw(alignments_.procmin_);
471 if (procmax_.
size()) {
472 std::ostringstream tmp;
473 tmp <<
", proc max="<<procmax_[i];
476 if (options.align_columns)
477 os << std::left << std::setw(alignments_.procmax_);
481 std::ostringstream tmp;
482 tmp <<
", std dev="<<sqrt(std::max<double>(sum_sq_[i]-sum_[i]*sum_[i]/active_[i],0.0)/(active_[i]-1));
484 if (options.align_columns)
485 os << std::left << std::setw(alignments_.stddev_);
489 else if ( options.output_minmax) {
491 size_t offset = alignments_.min_ + alignments_.max_ + alignments_.stddev_;
492 for (
size_t j=0; j < offset; ++j)
497 if ( options.output_histogram && active_[i] >1 ) {
498 std::ostringstream tmp;
500 for (
int h=0;h<options.num_histogram; ++h) {
502 tmp <<
", "<<hist_[h][i];
507 if (options.align_columns)
508 os << std::left << std::setw(alignments_.histogram_);
511 else if ( options.output_histogram) {
513 for (
size_t j=0; j < alignments_.histogram_; ++j)
517 if (! options.print_names_before_values) {
518 std::ostringstream tmp;
520 for (
int l=0; l<level; ++l) {
524 tmp << split_names.second <<
": ";
530 double sub_time =
printLevel(flat_names_[i], level+1, os, printed, sum_[i]/active_[i], options);
534 if (options.print_names_before_values) {
535 std::ostringstream tmp;
536 for (
int l=0; l<=level; ++l)
538 tmp <<
"Remainder: ";
539 if (options.align_columns)
540 os << std::left << std::setw(alignments_.timer_names_);
544 std::ostringstream tmp;
545 tmp << sum_[i]/active_[i]- sub_time;
546 if (options.align_columns)
547 os << std::left << std::setw(alignments_.average_time_);
550 if ( options.output_fraction && (sum_[i]/active_[i] > 0.) ) {
551 if (options.align_columns)
552 os << std::left << std::setw(alignments_.fraction_);
553 std::ostringstream tmp;
554 tmp <<
" - "<< (sum_[i]/active_[i]- sub_time)/(sum_[i]/active_[i])*100 <<
"%";
557 if (! options.print_names_before_values) {
560 offset += alignments_.count_;
561 if (options.output_total_updates)
562 offset += alignments_.total_updates_;
563 if (options.output_minmax)
564 offset += alignments_.min_ + alignments_.max_ + alignments_.stddev_;
565 if (options.output_histogram)
566 offset += alignments_.histogram_;
567 for (
size_t j=0; j < offset; ++j)
570 std::ostringstream tmp;
572 for (
int l=0; l<=level; ++l)
574 tmp <<
"Remainder: ";
575 if (options.align_columns)
576 os << std::left << std::setw(alignments_.timer_names_);
581 total_time += sum_[i]/active_[i];
586 static void printXMLEscapedString(std::ostream& os,
const std::string& str)
622 StackedTimer::printLevelXML (std::string prefix,
int print_level, std::ostream& os, std::vector<bool> &printed,
double parent_time,
const std::string& rootName)
624 constexpr
int indSpaces = 2;
625 int indent = indSpaces * print_level;
627 double total_time = 0.0;
629 for (
int i=0; i<flat_names_.
size(); ++i) {
632 int level = std::count(flat_names_[i].begin(), flat_names_[i].end(),
'@');
633 if ( level != print_level)
635 auto split_names = getPrefix(flat_names_[i]);
636 if ( prefix != split_names.first)
639 for (
int j = 0; j < indent; j++)
641 os <<
"<timing name=\"";
642 if(level == 0 && rootName.length())
643 printXMLEscapedString(os, rootName);
645 printXMLEscapedString(os, split_names.second);
646 os <<
"\" value=\"" << sum_[i]/active_[i] <<
"\"";
650 std::ostringstream osInner;
651 double sub_time =
printLevelXML(flat_names_[i], print_level+1, osInner, printed, sum_[i]/active_[i]);
652 std::string innerContents = osInner.str();
653 if(innerContents.length())
659 for (
int j = 0; j < indent + indSpaces; j++)
661 os <<
"<timing name=\"Remainder\" value=\"" << (sum_[i]/active_[i] - sub_time) <<
"\"/>\n";
664 for (
int j = 0; j < indent; j++)
673 total_time += sum_[i]/active_[i];
681 if (rank(*comm) == 0 ) {
682 if (options.print_warnings) {
683 os <<
"*** Teuchos::StackedTimer::report() - Remainder for a level will be ***"
684 <<
"\n*** incorrect if a timer in the level does not exist on every rank ***"
685 <<
"\n*** of the MPI Communicator. ***"
688 if ( (options.max_levels != INT_MAX) && options.print_warnings) {
689 os <<
"Teuchos::StackedTimer::report() - max_levels manually set to " << options.max_levels
690 <<
". \nTo print more levels, increase value of OutputOptions::max_levels." << std::endl;
692 if ( (! options.print_names_before_values) && (! options.align_columns)) {
693 options.align_columns =
true;
694 if (options.print_warnings)
695 os <<
"Teuchos::StackedTimer::report() - option print_names_before_values=false "
696 <<
"\nrequires that the option align_columns=true too. Setting the value for "
697 <<
"\nalign_column to true."
700 if (options.align_columns) {
701 std::vector<bool> printed(flat_names_.
size(),
false);
705 std::vector<bool> printed(flat_names_.
size(),
false);
715 if (rank(*comm) == 0 ) {
716 std::vector<bool> printed(flat_names_.
size(),
false);
717 os <<
"<?xml version=\"1.0\"?>\n";
718 os <<
"<performance-report date=\"" << timestamp <<
"\" name=\"nightly_run_" << datestamp <<
"\" time-units=\"seconds\">\n";
720 os <<
"</performance-report>\n";
726 const char* rawWatchrDir = getenv(
"WATCHR_PERF_DIR");
727 const char* rawBuildName = getenv(
"WATCHR_BUILD_NAME");
728 const char* rawGitSHA = getenv(
"TRILINOS_GIT_SHA");
729 const char* rawBuildDateOverride = getenv(
"WATCHR_BUILD_DATE");
733 std::string watchrDir = rawWatchrDir;
734 if(!watchrDir.length())
740 std::string buildName = rawBuildName ? rawBuildName :
"";
741 std::string datestamp;
742 std::string timestamp;
748 tstruct = gmtime(&t);
749 if(rawBuildDateOverride)
752 int year = 0, month = 0, day = 0;
753 sscanf(rawBuildDateOverride,
"%d_%d_%d", &year, &month, &day);
755 if(year <= 2000 || year > 2100)
756 throw std::invalid_argument(
"$WATCHR_BUILD_DATE has invalid year or is not in YYYY_MM_DD format.");
757 if(month < 1 || month > 12)
758 throw std::invalid_argument(
"$WATCHR_BUILD_DATE has invalid month or is not in YYYY_MM_DD format.");
759 if(day < 1 || day > 31)
760 throw std::invalid_argument(
"$WATCHR_BUILD_DATE has invalid day or is not in YYYY_MM_DD format.");
761 snprintf(buf, 256,
"%04d_%02d_%02d", year, month, day);
763 strftime(buf, 256,
"T%H:%M:%S", tstruct);
764 std::string justTime = buf;
765 snprintf(buf, 256,
"%04d-%02d-%02d", year, month, day);
766 timestamp = std::string(buf) + justTime;
770 strftime(buf, 256,
"%Y_%m_%d", tstruct);
772 strftime(buf, 256,
"%FT%H:%M:%S", tstruct);
778 std::string fullFile;
780 if(rank(*comm) == 0) {
781 std::string nameNoSpaces = name;
782 for(
char& c : nameNoSpaces)
787 if(buildName.length())
790 std::string buildNameNoSpaces = buildName;
791 for(
char& c : buildNameNoSpaces)
796 fullFile = watchrDir +
'/' + buildNameNoSpaces +
"-" + nameNoSpaces +
'_' + datestamp +
".xml";
799 fullFile = watchrDir +
'/' + nameNoSpaces +
'_' + datestamp +
".xml";
800 std::ofstream os(fullFile);
801 std::vector<bool> printed(flat_names_.
size(),
false);
802 os <<
"<?xml version=\"1.0\"?>\n";
803 os <<
"<performance-report date=\"" << timestamp <<
"\" name=\"nightly_run_" << datestamp <<
"\" time-units=\"seconds\">\n";
806 std::string gitSHA(rawGitSHA);
808 if(gitSHA.length() > 10)
809 gitSHA = gitSHA.substr(0, 10);
810 os <<
" <metadata key=\"Trilinos Version\" value=\"" << gitSHA <<
"\"/>\n";
812 printLevelXML(
"", 0, os, printed, 0.0, buildName +
": " + name);
813 os <<
"</performance-report>\n";
838 global_mpi_aggregation_called_ =
true;
844 return sum_[i] / active_[i];
850 return static_cast<double>(count_[i]) / static_cast<double>(active_[i]);
856 "ERROR: StackedTimer::getAverageMpiTime() - must call aggregateMpiData() first!");
858 auto search = std::find(flat_names_.
begin(),flat_names_.
end(),flat_timer_name);
861 "ERROR: StackedTimer::getAverageMpiTime() - the timer named \""
862 << flat_timer_name <<
"\" does not exist!");
864 auto i = std::distance(flat_names_.
begin(),search);
865 return static_cast<int>(i);
871 "ERROR: StackedTimer::isTimer() - must call aggregateMpiData() before using this query!");
873 auto search = std::find(flat_names_.
begin(),flat_names_.
end(),flat_timer_name);
874 return (search == flat_names_.
end()) ?
false :
true;
bool isTimer(const std::string &flat_timer_name)
void setVerboseOstream(const Teuchos::RCP< std::ostream > &os)
Set the ostream for verbose mode(defaults to std::cout).
void enableVerboseTimestamps(const unsigned levels)
Enable timestamps in verbose mode for the number of levels specified.
void enableVerbose(const bool enable_verbose)
If set to true, print timer start/stop to verbose ostream.
void merge(Teuchos::RCP< const Teuchos::Comm< int > > comm)
#define TEUCHOS_TEST_FOR_EXCEPTION(throw_exception_test, Exception, msg)
Macro for throwing an exception with breakpointing to ease debugging.
bool enable_verbose_
If set to true, prints to the debug ostream. At construction, default value is set from environment v...
T * getRawPtr()
Return a raw pointer to beginning of array or NULL if unsized.
double printLevelXML(std::string prefix, int level, std::ostream &os, std::vector< bool > &printed, double parent_time, const std::string &rootName="")
double getMpiAverageCount(const std::string &flat_timer_name)
bool enable_timers_
Used to disable timers for asynchronous work.
std::string reportWatchrXML(const std::string &name, Teuchos::RCP< const Teuchos::Comm< int > > comm)
unsigned verbose_timestamp_levels_
If set to a value greater than 0, verbose mode will print that many levels of timers with timestamps...
BaseTimer::TimeInfo findTimer(const std::string &name, bool &found)
double printLevel(std::string prefix, int level, std::ostream &os, std::vector< bool > &printed, double parent_time, const OutputOptions &options)
double accumulatedTime(const std::string &name="")
void report(std::ostream &os)
void error_out(const std::string &msg, const bool)
Error reporting function for stacked timer.
The basic timer used internally, uses std::chrono::high_resolution_clock.
double computeColumnWidthsForAligment(std::string prefix, int print_level, std::vector< bool > &printed, double parent_time, const OutputOptions &options)
void reportXML(std::ostream &os, const std::string &datestamp, const std::string ×tamp, Teuchos::RCP< const Teuchos::Comm< int > > comm)
void collectRemoteData(Teuchos::RCP< const Teuchos::Comm< int > > comm, const OutputOptions &options)
void mergeCounterNames(const Comm< int > &comm, const Array< std::string > &localNames, Array< std::string > &globalNames, const ECounterSetOp setOp)
Merge counter names over all processors.
void resize(size_type new_size, const value_type &x=value_type())
Teuchos::RCP< std::ostream > verbose_ostream_
For debugging, this is the ostream used for printing.
LevelTimer timer_
Base timer.
double getMpiAverageTime(const std::string &flat_timer_name)
int getFlatNameIndex(const std::string &flat_timer_name)
LevelTimer()
Default constructor, shouldn't be used but needed for std::vector.
const BaseTimer * findBaseTimer(const std::string &name) const
void aggregateMpiData(Teuchos::RCP< const Teuchos::Comm< int > > comm, OutputOptions options=OutputOptions())
Smart reference counting pointer class for automatic garbage collection.