Merge remote-tracking branch 'parallax/master'

Signed-off-by: Matt Liberty <mliberty@precisioninno.com>
This commit is contained in:
Matt Liberty 2025-04-14 22:13:14 +00:00
commit eb7bc4c3aa
126 changed files with 1071 additions and 1082 deletions

3
.gitignore vendored
View File

@ -32,3 +32,6 @@ test/results
test/b3v3_1check.log
doc/messages.txt
# clangd turds
.cache/

View File

@ -155,6 +155,7 @@ set(STA_SOURCE
sdc/Sdc.cc
sdc/SdcGraph.cc
sdc/SdcCmdComment.cc
sdc/Variables.cc
sdc/WriteSdc.cc
sdf/ReportAnnotation.cc

View File

@ -48,6 +48,7 @@
#include "ArcDelayCalc.hh"
#include "LumpedCapDelayCalc.hh"
#include "GraphDelayCalc.hh"
#include "Variables.hh"
#include "Arnoldi.hh"
#include "ArnoldiReduce.hh"
@ -64,6 +65,7 @@ namespace sta {
// ra_get_s
using std::abs;
using std::vector;
struct delay_work;
struct delay_c;
@ -234,6 +236,7 @@ private:
ArnoldiReduce *reduce_;
delay_work *delay_work_;
vector<rcmodel*> unsaved_parasitics_;
bool pocv_enabled_;
};
ArcDelayCalc *
@ -391,6 +394,7 @@ ArnoldiDelayCalc::gateDelay(const Pin *drvr_pin,
ConcreteParasitic *cparasitic =
reinterpret_cast<ConcreteParasitic*>(const_cast<Parasitic*>(parasitic));
rcmodel_ = dynamic_cast<rcmodel*>(cparasitic);
pocv_enabled_ = variables_->pocvEnabled();
GateTableModel *table_model = arc->gateTableModel(dcalc_ap);
if (table_model && rcmodel_) {
const Pvt *pvt = pinPvt(drvr_pin, dcalc_ap);

View File

@ -38,6 +38,8 @@
namespace sta {
using std::string;
rcmodel::rcmodel() :
pinV(nullptr)
{

View File

@ -29,9 +29,7 @@
namespace sta {
using std::vector;
typedef map<const Pin*, FloatSeq, PinIdLess> WatchPinValuesMap;
typedef std::map<const Pin*, FloatSeq, PinIdLess> WatchPinValuesMap;
ArcDelayCalc *
makeCcsCeffDelayCalc(StaState *sta);
@ -68,7 +66,7 @@ public:
Waveform watchWaveform(const Pin *pin) override;
protected:
typedef vector<double> Region;
typedef std::vector<double> Region;
void gateDelaySlew(const LibertyLibrary *drvr_library,
const RiseFall *rf,

View File

@ -35,6 +35,7 @@
#include "Corner.hh"
#include "DcalcAnalysisPt.hh"
#include "GraphDelayCalc.hh"
#include "Variables.hh"
namespace sta {
@ -167,7 +168,8 @@ DelayCalcBase::checkDelay(const Pin *check_pin,
float from_slew1 = delayAsFloat(from_slew);
float to_slew1 = delayAsFloat(to_slew);
return model->checkDelay(pinPvt(check_pin, dcalc_ap), from_slew1, to_slew1,
related_out_cap, pocv_enabled_);
related_out_cap,
variables_->pocvEnabled());
}
else
return delay_zero;

View File

@ -47,6 +47,7 @@
#include "DcalcAnalysisPt.hh"
#include "ArcDelayCalc.hh"
#include "FindRoot.hh"
#include "Variables.hh"
namespace sta {
@ -371,7 +372,8 @@ DmpAlg::gateCapDelaySlew(double ceff,
{
ArcDelay model_delay;
Slew model_slew;
gate_model_->gateDelay(pvt_, in_slew_, ceff, pocv_enabled_,
gate_model_->gateDelay(pvt_, in_slew_, ceff,
variables_->pocvEnabled(),
model_delay, model_slew);
delay = delayAsFloat(model_delay);
slew = delayAsFloat(model_slew);
@ -1562,7 +1564,7 @@ DmpCeffDelayCalc::setCeffAlgorithm(const LibertyLibrary *drvr_library,
double rd = 0.0;
if (gate_model) {
rd = gateModelRd(drvr_cell, gate_model, rf, in_slew, c2, c1,
pvt, pocv_enabled_);
pvt, variables_->pocvEnabled());
// Zero Rd means the table is constant and thus independent of load cap.
if (rd < 1e-2
// Rpi is small compared to Rd, which makes the load capacitive.
@ -1630,9 +1632,10 @@ DmpCeffDelayCalc::reportGateDelay(const Pin *drvr_pin,
const Unit *time_unit = units->timeUnit();
float in_slew1 = delayAsFloat(in_slew);
result += model->reportGateDelay(pinPvt(drvr_pin, dcalc_ap), in_slew1, c_eff,
pocv_enabled_, digits);
variables_->pocvEnabled(), digits);
result += "Driver waveform slew = ";
result += time_unit->asString(dcalc_result.drvrSlew(), digits);
float drvr_slew = delayAsFloat(dcalc_result.drvrSlew());
result += time_unit->asString(drvr_slew, digits);
result += '\n';
}
return result;

View File

@ -45,10 +45,12 @@
#include "DcalcAnalysisPt.hh"
#include "NetCaps.hh"
#include "ClkNetwork.hh"
#include "Variables.hh"
namespace sta {
using std::abs;
using std::array;
static const Slew default_slew = 0.0;
@ -365,7 +367,7 @@ GraphDelayCalc::seedNoDrvrCellSlew(Vertex *drvr_vertex,
else {
// Top level bidirect driver uses load slew unless
// bidirect instance paths are disabled.
if (sdc_->bidirectDrvrSlewFromLoad(drvr_pin)) {
if (bidirectDrvrSlewFromLoad(drvr_pin)) {
Vertex *load_vertex = graph_->pinLoadVertex(drvr_pin);
slew = graph_->slew(load_vertex, rf, ap_index);
}
@ -393,6 +395,17 @@ GraphDelayCalc::seedNoDrvrCellSlew(Vertex *drvr_vertex,
arc_delay_calc->finishDrvrPin();
}
// Delay calculation propagates slews from a bidirect driver
// to the bidirect port and back through the bidirect driver when
// sta_bidirect_inst_paths_enabled_ is true.
bool
GraphDelayCalc::bidirectDrvrSlewFromLoad(const Pin *pin) const
{
return variables_->bidirectInstPathsEnabled()
&& network_->direction(pin)->isBidirect()
&& network_->isTopLevelPort(pin);
}
void
GraphDelayCalc::seedNoDrvrSlew(Vertex *drvr_vertex,
const Pin *drvr_pin,
@ -405,7 +418,7 @@ GraphDelayCalc::seedNoDrvrSlew(Vertex *drvr_vertex,
Slew slew(default_slew);
// Top level bidirect driver uses load slew unless
// bidirect instance paths are disabled.
if (sdc_->bidirectDrvrSlewFromLoad(drvr_pin)) {
if (bidirectDrvrSlewFromLoad(drvr_pin)) {
Vertex *load_vertex = graph_->pinLoadVertex(drvr_pin);
slew = graph_->slew(load_vertex, rf, ap_index);
}
@ -1185,7 +1198,7 @@ GraphDelayCalc::annotateLoadDelays(Vertex *drvr_vertex,
if (load_changed && observer_)
observer_->delayChangedTo(load_vertex);
// Enqueue bidirect driver from load vertex.
if (sdc_->bidirectDrvrSlewFromLoad(load_pin))
if (bidirectDrvrSlewFromLoad(load_pin))
iter_->enqueue(graph_->pinDrvrVertex(load_pin));
changed |= load_changed;
}

View File

@ -37,6 +37,7 @@
#include "Parasitics.hh"
#include "DcalcAnalysisPt.hh"
#include "GraphDelayCalc.hh"
#include "Variables.hh"
namespace sta {
@ -144,7 +145,8 @@ LumpedCapDelayCalc::gateDelay(const Pin *drvr_pin,
// NaNs cause seg faults during table lookup.
if (isnan(load_cap) || isnan(delayAsFloat(in_slew)))
report_->error(1350, "gate delay input variable is NaN");
model->gateDelay(pinPvt(drvr_pin, dcalc_ap), in_slew1, load_cap, pocv_enabled_,
model->gateDelay(pinPvt(drvr_pin, dcalc_ap), in_slew1, load_cap,
variables_->pocvEnabled(),
gate_delay, drvr_slew);
return makeResult(drvr_library, rf, gate_delay, drvr_slew, load_pin_index_map);
}

View File

@ -34,6 +34,8 @@
namespace sta {
using std::vector;
ParallelDelayCalc::ParallelDelayCalc(StaState *sta):
DelayCalcBase(sta)
{

View File

@ -285,7 +285,7 @@ PrimaDelayCalc::simulate()
simulate1(Gq_, Cq_, Bq_, xq_init_, Vq_, prima_order_);
}
else {
MatrixXd x_to_v = MatrixXd::Identity(order_, order_);
Eigen::MatrixXd x_to_v = Eigen::MatrixXd::Identity(order_, order_);
simulate1(G_, C_, B_, x_init_, x_to_v, order_);
}
}
@ -293,14 +293,14 @@ PrimaDelayCalc::simulate()
void
PrimaDelayCalc::simulate1(const MatrixSd &G,
const MatrixSd &C,
const MatrixXd &B,
const VectorXd &x_init,
const MatrixXd &x_to_v,
const Eigen::MatrixXd &B,
const Eigen::VectorXd &x_init,
const Eigen::MatrixXd &x_to_v,
const size_t order)
{
VectorXd x(order);
VectorXd x_prev(order);
VectorXd x_prev2(order);
Eigen::VectorXd x(order);
Eigen::VectorXd x_prev(order);
Eigen::VectorXd x_prev2(order);
v_.resize(order);
v_prev_.resize(order);
@ -321,7 +321,7 @@ PrimaDelayCalc::simulate1(const MatrixSd &G,
// Initial time depends on ceff which impact delay, so use a sim step
// to find an initial ceff.
setPortCurrents();
VectorXd rhs(order);
Eigen::VectorXd rhs(order);
rhs = B * u_ + (1.0 / time_step_) * C * (3.0 * x_prev - x_prev2);
x = A_solver.solve(rhs);
v_ = x_to_v * x;
@ -771,12 +771,12 @@ PrimaDelayCalc::primaReduce()
SparseLU<MatrixSd> G_solver(G_);
if (G_solver.info() != Eigen::Success)
report_->error(1752, "G matrix is singular.");
MatrixXd R(order_, port_count_);
Eigen::MatrixXd R(order_, port_count_);
R = G_solver.solve(B_);
// Step 4
HouseholderQR<MatrixXd> R_solver(R);
MatrixXd Q = R_solver.householderQ();
Eigen::HouseholderQR<Eigen::MatrixXd> R_solver(R);
Eigen::MatrixXd Q = R_solver.householderQ();
// Vq is "X" in the prima paper (too many "x" variables in the paper).
Vq_.resize(order_, prima_order_);
@ -785,7 +785,7 @@ PrimaDelayCalc::primaReduce()
// Step 6 - Arnolid iteration
for (size_t k = 1; k < prima_order_; k++) {
VectorXd V = C_ * Vq_.col(k - 1);
Eigen::VectorXd V = C_ * Vq_.col(k - 1);
Vq_.col(k) = G_solver.solve(V);
// Modified Gram-Schmidt orthonormalization
@ -793,9 +793,9 @@ PrimaDelayCalc::primaReduce()
double H = Vq_.col(j).transpose() * Vq_.col(k);
Vq_.col(k) = Vq_.col(k) - H * Vq_.col(j);
}
VectorXd Vq_k = Vq_.col(k);
HouseholderQR<MatrixXd> Vq_k_solver(Vq_k);
MatrixXd VqQ = Vq_k_solver.householderQ();
Eigen::VectorXd Vq_k = Vq_.col(k);
Eigen::HouseholderQR<Eigen::MatrixXd> Vq_k_solver(Vq_k);
Eigen::MatrixXd VqQ = Vq_k_solver.householderQ();
Vq_.col(k) = VqQ.col(0);
}
@ -824,36 +824,36 @@ PrimaDelayCalc::primaReduce2()
{
G_.makeCompressed();
// Step 3: solve G*R = B for R
SparseLU<MatrixSd> G_solver(G_);
MatrixXd R(order_, port_count_);
Eigen::SparseLU<MatrixSd> G_solver(G_);
Eigen::MatrixXd R(order_, port_count_);
R = G_solver.solve(B_);
// Step 4
HouseholderQR<MatrixXd> R_solver(R);
MatrixXd Q = R_solver.householderQ();
Eigen::HouseholderQR<Eigen::MatrixXd> R_solver(R);
Eigen::MatrixXd Q = R_solver.householderQ();
// Vq is "X" in the prima paper (too many "x" variables in the paper).
size_t n = ceil(prima_order_ / static_cast<double>(port_count_));
MatrixXd Vq(order_, n * port_count_);
Eigen::MatrixXd Vq(order_, n * port_count_);
// // Vq = first port_count columns of Q.
Vq.block(0, 0, order_, port_count_) = Q.block(0, 0, order_, port_count_);
// Step 6 - Arnolid iteration
for (size_t k = 1; k < n; k++) {
MatrixXd V = C_ * Vq.block(0, (k - 1) * port_count_, order_, port_count_);
MatrixXd GV = G_solver.solve(V);
Eigen::MatrixXd V = C_ * Vq.block(0, (k - 1) * port_count_, order_, port_count_);
Eigen::MatrixXd GV = G_solver.solve(V);
Vq.block(0, k * port_count_, order_, port_count_) = GV;
// Modified Gram-Schmidt orthonormalization
for (size_t j = 0; j < k; j++) {
MatrixXd H = Vq.block(0, j * port_count_, order_, port_count_).transpose()
Eigen::MatrixXd H = Vq.block(0, j * port_count_, order_, port_count_).transpose()
* Vq.block(0, k * port_count_, order_, port_count_);
Vq.block(0, k * port_count_, order_, port_count_) =
Vq.block(0, k * port_count_, order_, port_count_) - Vq.block(0, j * port_count_, order_, port_count_) * H;
}
MatrixXd Vq_k = Vq.block(0, k * port_count_, order_, port_count_);
HouseholderQR<MatrixXd> Vq_k_solver(Vq_k);
MatrixXd VqQ = Vq_k_solver.householderQ();
Eigen::MatrixXd Vq_k = Vq.block(0, k * port_count_, order_, port_count_);
Eigen::HouseholderQR<Eigen::MatrixXd> Vq_k_solver(Vq_k);
Eigen::MatrixXd VqQ = Vq_k_solver.householderQ();
Vq.block(0, k * port_count_, order_, port_count_) =
VqQ.block(0, 0, order_, port_count_);
}
@ -970,7 +970,7 @@ PrimaDelayCalc::reportMatrix(const char *name,
void
PrimaDelayCalc::reportMatrix(const char *name,
MatrixXd &matrix)
Eigen::MatrixXd &matrix)
{
report_->reportLine("%s", name);
reportMatrix(matrix);
@ -978,7 +978,7 @@ PrimaDelayCalc::reportMatrix(const char *name,
void
PrimaDelayCalc::reportMatrix(const char *name,
VectorXd &matrix)
Eigen::VectorXd &matrix)
{
report_->reportLine("%s", name);
reportMatrix(matrix);
@ -986,7 +986,7 @@ PrimaDelayCalc::reportMatrix(const char *name,
void
PrimaDelayCalc::reportVector(const char *name,
vector<double> &matrix)
std::vector<double> &matrix)
{
report_->reportLine("%s", name);
reportVector(matrix);
@ -995,10 +995,10 @@ PrimaDelayCalc::reportVector(const char *name,
void
PrimaDelayCalc::reportMatrix(MatrixSd &matrix)
{
for (Index i = 0; i < matrix.rows(); i++) {
for (Eigen::Index i = 0; i < matrix.rows(); i++) {
string line = "| ";
for (Index j = 0; j < matrix.cols(); j++) {
string entry = stdstrPrint("%10.3e", matrix.coeff(i, j));
for (Eigen::Index j = 0; j < matrix.cols(); j++) {
std::string entry = stdstrPrint("%10.3e", matrix.coeff(i, j));
line += entry;
line += " ";
}
@ -1008,12 +1008,12 @@ PrimaDelayCalc::reportMatrix(MatrixSd &matrix)
}
void
PrimaDelayCalc::reportMatrix(MatrixXd &matrix)
PrimaDelayCalc::reportMatrix(Eigen::MatrixXd &matrix)
{
for (Index i = 0; i < matrix.rows(); i++) {
string line = "| ";
for (Index j = 0; j < matrix.cols(); j++) {
string entry = stdstrPrint("%10.3e", matrix.coeff(i, j));
for (Eigen::Index i = 0; i < matrix.rows(); i++) {
std::string line = "| ";
for (Eigen::Index j = 0; j < matrix.cols(); j++) {
std::string entry = stdstrPrint("%10.3e", matrix.coeff(i, j));
line += entry;
line += " ";
}
@ -1023,11 +1023,11 @@ PrimaDelayCalc::reportMatrix(MatrixXd &matrix)
}
void
PrimaDelayCalc::reportMatrix(VectorXd &matrix)
PrimaDelayCalc::reportMatrix(Eigen::VectorXd &matrix)
{
string line = "| ";
for (Index i = 0; i < matrix.rows(); i++) {
string entry = stdstrPrint("%10.3e", matrix.coeff(i));
std::string line = "| ";
for (Eigen::Index i = 0; i < matrix.rows(); i++) {
std::string entry = stdstrPrint("%10.3e", matrix.coeff(i));
line += entry;
line += " ";
}
@ -1036,11 +1036,11 @@ PrimaDelayCalc::reportMatrix(VectorXd &matrix)
}
void
PrimaDelayCalc::reportVector(vector<double> &matrix)
PrimaDelayCalc::reportVector(std::vector<double> &matrix)
{
string line = "| ";
std::string line = "| ";
for (size_t i = 0; i < matrix.size(); i++) {
string entry = stdstrPrint("%10.3e", matrix[i]);
std::string entry = stdstrPrint("%10.3e", matrix[i]);
line += entry;
line += " ";
}

View File

@ -40,21 +40,12 @@ class ArcDelayCalc;
class StaState;
class Corner;
using std::vector;
using std::array;
using Eigen::MatrixXd;
using Eigen::MatrixXcd;
using Eigen::VectorXd;
using Eigen::SparseMatrix;
using Eigen::Index;
using std::map;
typedef Map<const Pin*, size_t, PinIdLess> PinNodeMap;
typedef map<const ParasiticNode*, size_t, ParasiticNodeLess> NodeIndexMap;
typedef std::map<const ParasiticNode*, size_t, ParasiticNodeLess> NodeIndexMap;
typedef Map<const Pin*, size_t> PortIndexMap;
typedef SparseMatrix<double> MatrixSd;
typedef Map<const Pin*, VectorXd, PinIdLess> PinLMap;
typedef map<const Pin*, FloatSeq, PinIdLess> WatchPinValuesMap;
typedef Eigen::SparseMatrix<double> MatrixSd;
typedef Map<const Pin*, Eigen::VectorXd, PinIdLess> PinLMap;
typedef std::map<const Pin*, FloatSeq, PinIdLess> WatchPinValuesMap;
typedef Table1 Waveform;
@ -96,14 +87,14 @@ public:
ArcDcalcResultSeq gateDelays(ArcDcalcArgSeq &dcalc_args,
const LoadPinIndexMap &load_pin_index_map,
const DcalcAnalysisPt *dcalc_ap) override;
string reportGateDelay(const Pin *drvr_pin,
const TimingArc *arc,
const Slew &in_slew,
float load_cap,
const Parasitic *parasitic,
const LoadPinIndexMap &load_pin_index_map,
const DcalcAnalysisPt *dcalc_ap,
int digits) override;
std::string reportGateDelay(const Pin *drvr_pin,
const TimingArc *arc,
const Slew &in_slew,
float load_cap,
const Parasitic *parasitic,
const LoadPinIndexMap &load_pin_index_map,
const DcalcAnalysisPt *dcalc_ap,
int digits) override;
// Record waveform for drvr/load pin.
void watchPin(const Pin *pin) override;
@ -116,9 +107,9 @@ protected:
void simulate();
void simulate1(const MatrixSd &G,
const MatrixSd &C,
const MatrixXd &B,
const VectorXd &x_init,
const MatrixXd &x_to_v,
const Eigen::MatrixXd &B,
const Eigen::VectorXd &x_init,
const Eigen::MatrixXd &x_to_v,
const size_t order);
double maxTime();
double timeStep();
@ -164,15 +155,15 @@ protected:
void reportMatrix(const char *name,
MatrixSd &matrix);
void reportMatrix(const char *name,
MatrixXd &matrix);
Eigen::MatrixXd &matrix);
void reportMatrix(const char *name,
VectorXd &matrix);
Eigen::VectorXd &matrix);
void reportVector(const char *name,
vector<double> &matrix);
std::vector<double> &matrix);
void reportMatrix(MatrixSd &matrix);
void reportMatrix(MatrixXd &matrix);
void reportMatrix(VectorXd &matrix);
void reportVector(vector<double> &matrix);
void reportMatrix(Eigen::MatrixXd &matrix);
void reportMatrix(Eigen::VectorXd &matrix);
void reportVector(std::vector<double> &matrix);
ArcDcalcArgSeq *dcalc_args_;
size_t drvr_count_;
@ -184,10 +175,10 @@ protected:
PinNodeMap pin_node_map_; // Parasitic pin -> array index
NodeIndexMap node_index_map_; // Parasitic node -> array index
vector<OutputWaveforms*> output_waveforms_;
std::vector<OutputWaveforms*> output_waveforms_;
double resistance_sum_;
vector<double> node_capacitances_;
std::vector<double> node_capacitances_;
bool includes_pin_caps_;
float coupling_cap_multiplier_;
@ -199,25 +190,25 @@ protected:
// G*x(t) + C*x'(t) = B*u(t)
MatrixSd G_;
MatrixSd C_;
MatrixXd B_;
VectorXd x_init_;
VectorXd u_;
Eigen::MatrixXd B_;
Eigen::VectorXd x_init_;
Eigen::VectorXd u_;
// Prima reduced MNA eqns
size_t prima_order_;
MatrixXd Vq_;
Eigen::MatrixXd Vq_;
MatrixSd Gq_;
MatrixSd Cq_;
MatrixXd Bq_;
VectorXd xq_init_;
Eigen::MatrixXd Bq_;
Eigen::VectorXd xq_init_;
// Node voltages.
VectorXd v_; // voltage[node_idx]
VectorXd v_prev_;
Eigen::VectorXd v_; // voltage[node_idx]
Eigen::VectorXd v_prev_;
// Indexed by driver index.
vector<double> ceff_;
vector<double> drvr_current_;
std::vector<double> ceff_;
std::vector<double> drvr_current_;
double time_step_;
double time_step_prev_;
@ -240,11 +231,11 @@ protected:
static constexpr size_t threshold_vth = 1;
static constexpr size_t threshold_vh = 2;
static constexpr size_t measure_threshold_count_ = 3;
typedef array<double, measure_threshold_count_> ThresholdTimes;
typedef std::array<double, measure_threshold_count_> ThresholdTimes;
// Vl Vth Vh
ThresholdTimes measure_thresholds_;
// Indexed by node number.
vector<ThresholdTimes> threshold_times_;
std::vector<ThresholdTimes> threshold_times_;
// Delay calculator to use when ccs waveforms are missing from liberty.
ArcDelayCalc *table_dcalc_;

Binary file not shown.

View File

@ -32,6 +32,7 @@
#include "Fuzzy.hh"
#include "Units.hh"
#include "StaState.hh"
#include "Variables.hh"
// SSTA compilation.
#if (SSTA == 1)
@ -237,7 +238,7 @@ delayAsFloat(const Delay &delay,
const EarlyLate *early_late,
const StaState *sta)
{
if (sta->pocvEnabled()) {
if (sta->variables()->pocvEnabled()) {
if (early_late == EarlyLate::early())
return delay.mean() - delay.sigma() * sta->sigmaFactor();
else if (early_late == EarlyLate::late())
@ -268,7 +269,7 @@ delayAsString(const Delay &delay,
int digits)
{
const Unit *unit = sta->units()->timeUnit();
if (sta->pocvEnabled()) {
if (sta->variables()->pocvEnabled()) {
float sigma = delay.sigma();
return stringPrintTmp("%s[%s]",
unit->asString(delay.mean(), digits),

View File

@ -38,6 +38,8 @@
namespace sta {
using std::string;
////////////////////////////////////////////////////////////////
//
// Graph
@ -1298,7 +1300,8 @@ Edge::setArcDelayAnnotated(const TimingArc *arc,
if (index > sizeof(intptr_t) * 8
&& arc_delay_annotated_is_bits_) {
arc_delay_annotated_is_bits_ = false;
arc_delay_annotated_.seq_ = new vector<bool>(ap_count * RiseFall::index_count * 2);
size_t bit_count = ap_count * RiseFall::index_count * 2;
arc_delay_annotated_.seq_ = new std::vector<bool>(bit_count);
}
if (arc_delay_annotated_is_bits_) {
if (annotated)

View File

@ -40,10 +40,6 @@
namespace sta {
using std::string;
using std::vector;
using std::map;
class Corner;
class Parasitic;
class DcalcAnalysisPt;
@ -54,7 +50,7 @@ typedef std::vector<ArcDcalcArg*> ArcDcalcArgPtrSeq;
typedef std::vector<ArcDcalcArg> ArcDcalcArgSeq;
// Driver load pin -> index in driver loads.
typedef map<const Pin *, size_t, PinIdLess> LoadPinIndexMap;
typedef std::map<const Pin *, size_t, PinIdLess> LoadPinIndexMap;
// Arguments for gate delay calculation delay/slew at one driver pin
// through one timing arc at one delay calc analysis point.
@ -138,12 +134,12 @@ protected:
ArcDelay gate_delay_;
Slew drvr_slew_;
// Load wire delay and slews indexed by load pin index.
vector<ArcDelay> wire_delays_;
vector<Slew> load_slews_;
std::vector<ArcDelay> wire_delays_;
std::vector<Slew> load_slews_;
};
typedef vector<ArcDcalcArg> ArcDcalcArgSeq;
typedef vector<ArcDcalcResult> ArcDcalcResultSeq;
typedef std::vector<ArcDcalcArg> ArcDcalcArgSeq;
typedef std::vector<ArcDcalcResult> ArcDcalcResultSeq;
// Delay calculator class hierarchy.
// ArcDelayCalc

View File

@ -45,10 +45,10 @@ class PatternMatch;
class LibertyCell;
class LibertyPort;
typedef Map<string, ConcreteCell*> ConcreteCellMap;
typedef std::map<string, string> AttributeMap;
typedef Map<std::string, ConcreteCell*> ConcreteCellMap;
typedef std::map<std::string, std::string> AttributeMap;
typedef Vector<ConcretePort*> ConcretePortSeq;
typedef Map<string, ConcretePort*> ConcretePortMap;
typedef Map<std::string, ConcretePort*> ConcretePortMap;
typedef ConcreteCellMap::ConstIterator ConcreteLibraryCellIterator;
typedef ConcretePortSeq::ConstIterator ConcreteCellPortIterator;
typedef ConcretePortSeq::ConstIterator ConcretePortMemberIterator;
@ -82,9 +82,9 @@ protected:
void renameCell(ConcreteCell *cell,
const char *cell_name);
string name_;
std::string name_;
ObjectId id_;
string filename_;
std::string filename_;
bool is_liberty_;
char bus_brkt_left_;
char bus_brkt_right_;
@ -114,9 +114,9 @@ public:
ConcreteCellPortBitIterator *portBitIterator() const;
bool isLeaf() const { return is_leaf_; }
void setIsLeaf(bool is_leaf);
void setAttribute(const string &key,
const string &value);
string getAttribute(const string &key) const;
void setAttribute(const std::string &key,
const std::string &value);
std::string getAttribute(const std::string &key) const;
// Cell acts as port factory.
ConcretePort *makePort(const char *name);
@ -156,10 +156,10 @@ protected:
const char *name,
int index);
string name_;
std::string name_;
ObjectId id_;
// Filename is optional.
string filename_;
std::string filename_;
ConcreteLibrary *library_;
LibertyCell *liberty_cell_;
// External application cell.
@ -236,7 +236,7 @@ protected:
ConcretePortSeq *member_ports,
ConcreteCell *cell);
string name_;
std::string name_;
ObjectId id_;
ConcreteCell *cell_;
PortDirection *direction_;

View File

@ -46,7 +46,7 @@ class ConcreteBindingTbl;
class ConcreteLibertyLibraryIterator;
typedef Vector<ConcreteLibrary*> ConcreteLibrarySeq;
typedef std::map<string, string> AttributeMap;
typedef std::map<std::string, std::string> AttributeMap;
typedef Map<const char*, ConcreteLibrary*, CharPtrLess> ConcreteLibraryMap;
typedef ConcreteLibrarySeq::ConstIterator ConcreteLibraryIterator;
typedef Map<const char *, ConcreteInstance*,
@ -83,8 +83,8 @@ public:
const PatternMatch *pattern) const override;
const char *name(const Cell *cell) const override;
string getAttribute(const Cell *cell,
const string &key) const override;
std::string getAttribute(const Cell *cell,
const std::string &key) const override;
ObjectId id(const Cell *cell) const override;
Library *library(const Cell *cell) const override;
LibertyCell *libertyCell(Cell *cell) const override;
@ -119,8 +119,8 @@ public:
PortMemberIterator *memberIterator(const Port *port) const override;
const char *name(const Instance *instance) const override;
string getAttribute(const Instance *inst,
const string &key) const override;
std::string getAttribute(const Instance *inst,
const std::string &key) const override;
ObjectId id(const Instance *instance) const override;
Cell *cell(const Instance *instance) const override;
Instance *parent(const Instance *instance) const override;
@ -189,8 +189,8 @@ public:
void setIsLeaf(Cell *cell,
bool is_leaf) override;
void setAttribute(Cell *cell,
const string &key,
const string &value) override;
const std::string &key,
const std::string &value) override;
Port *makePort(Cell *cell,
const char *name) override;
Port *makeBusPort(Cell *cell,
@ -223,8 +223,8 @@ public:
LibertyPort *port,
Net *net) override;
void setAttribute(Instance *inst,
const string &key,
const string &value) override;
const std::string &key,
const std::string &value) override;
void disconnectPin(Pin *pin) override;
void deletePin(Pin *pin) override;
Net *makeNet(const char *name,
@ -304,9 +304,9 @@ public:
InstanceNetIterator *netIterator() const;
Instance *findChild(const char *name) const;
InstanceChildIterator *childIterator() const;
void setAttribute(const string &key,
const string &value);
string getAttribute(const string &key) const;
void setAttribute(const std::string &key,
const std::string &value);
std::string getAttribute(const std::string &key) const;
void addChild(ConcreteInstance *child);
void deleteChild(ConcreteInstance *child);
void addPin(ConcretePin *pin);

View File

@ -126,7 +126,7 @@ protected:
void addPathAP(PathAnalysisPt *path_ap);
private:
string name_;
std::string name_;
int index_;
ParasiticAnalysisPtSeq parasitic_analysis_pts_;
DcalcAnalysisPtSeq dcalc_analysis_pts_;

View File

@ -29,32 +29,27 @@
namespace sta {
using std::string;
using std::map;
using std::initializer_list;
using std::pair;
// Helper for mapping enum values to strings and back.
template <class ENUM>
class EnumNameMap
{
public:
EnumNameMap(initializer_list<pair<const ENUM, string>> enum_names);
EnumNameMap(std::initializer_list<std::pair<const ENUM, std::string>> enum_names);
const char *find(ENUM key) const;
ENUM find(string name,
ENUM find(std::string name,
ENUM unknown_key) const;
void find(string name,
void find(std::string name,
// Return values.
ENUM &key,
bool &exists) const;
private:
map<ENUM, string> enum_map_;
map<string, ENUM> name_map_;
std::map<ENUM, std::string> enum_map_;
std::map<std::string, ENUM> name_map_;
};
template <class ENUM>
EnumNameMap<ENUM>::EnumNameMap(initializer_list<pair<const ENUM, string>> enum_names) :
EnumNameMap<ENUM>::EnumNameMap(std::initializer_list<std::pair<const ENUM,std::string>> enum_names) :
enum_map_(enum_names)
{
for (const auto& [key, name] : enum_map_)
@ -74,7 +69,7 @@ EnumNameMap<ENUM>::find(ENUM key) const
template <class ENUM>
void
EnumNameMap<ENUM>::find(string name,
EnumNameMap<ENUM>::find(std::string name,
// Return values.
ENUM &key,
bool &exists) const
@ -90,7 +85,7 @@ EnumNameMap<ENUM>::find(string name,
template <class ENUM>
ENUM
EnumNameMap<ENUM>::find(string name,
EnumNameMap<ENUM>::find(std::string name,
ENUM unknown_key) const
{
auto find_iter = name_map_.find(name);

View File

@ -48,7 +48,7 @@ public:
virtual bool suppressed() const { return suppressed_; }
private:
string msg_;
std::string msg_;
bool suppressed_;
};

View File

@ -32,8 +32,6 @@
namespace sta {
using std::string;
class FuncExpr
{
public:
@ -79,7 +77,7 @@ public:
TimingSense portTimingSense(const LibertyPort *port) const;
// Return true if expression has port as an input.
bool hasPort(const LibertyPort *port) const;
string to_string() const;
std::string to_string() const;
// Sub expression for a bus function (bit_offset is 0 to bus->size()-1).
FuncExpr *bitSubExpr(int bit_offset);
// Check to make sure the function and port size are compatible.
@ -88,9 +86,9 @@ public:
bool checkSize(LibertyPort *port);
private:
string to_string(bool with_parens) const;
string to_string(bool with_parens,
char op) const;
std::string to_string(bool with_parens) const;
std::string to_string(bool with_parens,
char op) const;
Operator op_;
FuncExpr *left_;

View File

@ -247,7 +247,7 @@ public:
~Vertex();
Pin *pin() const { return pin_; }
// Pin path with load/driver suffix for bidirects.
string to_string(const StaState *sta) const;
std::string to_string(const StaState *sta) const;
// compatibility
const char *name(const Network *network) const;
bool isBidirectDriver() const { return is_bidirect_drvr_; }
@ -366,7 +366,7 @@ class Edge
public:
Edge();
~Edge();
string to_string(const StaState *sta) const;
std::string to_string(const StaState *sta) const;
Vertex *to(const Graph *graph) const { return graph->vertex(to_); }
VertexId to() const { return to_; }
Vertex *from(const Graph *graph) const { return graph->vertex(from_); }
@ -426,7 +426,7 @@ protected:
ArcDelay *arc_delays_;
union {
uintptr_t bits_;
vector<bool> *seq_;
std::vector<bool> *seq_;
} arc_delay_annotated_;
bool arc_delay_annotated_is_bits_:1;
bool delay_annotation_is_incremental_:1;

View File

@ -35,8 +35,6 @@
namespace sta {
using std::vector;
// Class declarations for pointer references.
class Graph;
class Vertex;
@ -56,7 +54,7 @@ typedef int Level;
typedef int DcalcAPIndex;
typedef int TagGroupIndex;
typedef Vector<GraphLoop*> GraphLoopSeq;
typedef vector<Slew> SlewSeq;
typedef std::vector<Slew> SlewSeq;
static constexpr int level_max = std::numeric_limits<Level>::max();

View File

@ -38,17 +38,13 @@
namespace sta {
using std::vector;
using std::map;
using std::array;
class DelayCalcObserver;
class MultiDrvrNet;
class FindVertexDelays;
class NetCaps;
typedef Map<const Vertex*, MultiDrvrNet*> MultiDrvrNetMap;
typedef vector<SlewSeq> DrvrLoadSlews;
typedef std::vector<SlewSeq> DrvrLoadSlews;
// This class traverses the graph calling the arc delay calculator and
// annotating delays on graph edges.
@ -132,6 +128,7 @@ public:
const RiseFall *from_rf,
const TimingRole *role,
const DcalcAnalysisPt *dcalc_ap);
bool bidirectDrvrSlewFromLoad(const Pin *pin) const;
protected:
void seedInvalidDelays();
@ -190,7 +187,7 @@ protected:
ArcDelayCalc *arc_delay_calc,
LoadPinIndexMap &load_pin_index_map,
// Return value.
array<bool, RiseFall::index_count> &delay_exists);
std::array<bool, RiseFall::index_count> &delay_exists);
bool findDriverArcDelays(Vertex *drvr_vertex,
const MultiDrvrNet *multi_drvr,
Edge *edge,
@ -246,7 +243,6 @@ protected:
Slew checkEdgeClkSlew(const Vertex *from_vertex,
const RiseFall *from_rf,
const DcalcAnalysisPt *dcalc_ap);
bool bidirectDrvrSlewFromLoad(const Vertex *vertex) const;
float loadCap(const Pin *drvr_pin,
const RiseFall *rf,
const DcalcAnalysisPt *dcalc_ap,
@ -333,7 +329,7 @@ private:
Vertex *dcalc_drvr_;
VertexSeq drvrs_;
// [drvr_rf->index][dcalc_ap->index]
vector<NetCaps> net_caps_;
std::vector<NetCaps> net_caps_;
};
} // namespace

View File

@ -29,8 +29,6 @@
namespace sta {
using std::size_t;
const size_t hash_init_value = 5381;
// Dan Bernstein, comp.lang.c.

View File

@ -87,11 +87,11 @@ public:
const Pvt *pvt,
float in_slew,
float load_cap) const;
string reportPower(const LibertyCell *cell,
const Pvt *pvt,
float in_slew,
float load_cap,
int digits) const;
std::string reportPower(const LibertyCell *cell,
const Pvt *pvt,
float in_slew,
float load_cap,
int digits) const;
protected:
void findAxisValues(float in_slew,

View File

@ -88,9 +88,9 @@ typedef Map<const TimingArcSet*, LatchEnable*> LatchEnableMap;
typedef Vector<LatchEnable*> LatchEnableSeq;
typedef Map<const char *, OcvDerate*, CharPtrLess> OcvDerateMap;
typedef Vector<InternalPowerAttrs*> InternalPowerAttrsSeq;
typedef Map<string, float> SupplyVoltageMap;
typedef Map<string, LibertyPgPort*> LibertyPgPortMap;
typedef Map<string, DriverWaveform*> DriverWaveformMap;
typedef Map<std::string, float> SupplyVoltageMap;
typedef Map<std::string, LibertyPgPort*> LibertyPgPortMap;
typedef Map<std::string, DriverWaveform*> DriverWaveformMap;
typedef Vector<DcalcAnalysisPt*> DcalcAnalysisPtSeq;
enum class ClockGateType { none, latch_posedge, latch_negedge, other };
@ -647,8 +647,8 @@ protected:
bool has_internal_ports_;
std::atomic<bool> have_voltage_waveforms_;
std::mutex waveform_lock_;
string footprint_;
string user_function_class_;
std::string footprint_;
std::string user_function_class_;
private:
friend class LibertyLibrary;
@ -888,8 +888,8 @@ protected:
float min_pulse_width_[RiseFall::index_count];
const RiseFall *pulse_clk_trigger_;
const RiseFall *pulse_clk_sense_;
string related_ground_pin_;
string related_power_pin_;
std::string related_ground_pin_;
std::string related_power_pin_;
Vector<LibertyPort*> corner_ports_;
ReceiverModelPtr receiver_model_;
DriverWaveform *driver_waveform_[RiseFall::index_count];
@ -969,7 +969,7 @@ public:
void setWireloadTree(WireloadTree tree);
protected:
string name_;
std::string name_;
WireloadTree wire_load_tree_;
};
@ -996,7 +996,7 @@ public:
void print();
protected:
string name_;
std::string name_;
float scales_[scale_factor_type_count][scale_factor_pvt_count][RiseFall::index_count];
};
@ -1011,7 +1011,7 @@ public:
int to() const { return to_; }
protected:
string name_;
std::string name_;
int from_;
int to_;
};
@ -1032,7 +1032,7 @@ protected:
// Private to LibertyCell::makeModeDef.
ModeDef(const char *name);
string name_;
std::string name_;
ModeValueMap values_;
private:
@ -1056,9 +1056,9 @@ protected:
FuncExpr *cond,
const char *sdf_cond);
string value_;
std::string value_;
FuncExpr *cond_;
string sdf_cond_;
std::string sdf_cond_;
private:
friend class ModeDef;
@ -1085,7 +1085,7 @@ public:
void setAxis3(TableAxisPtr axis);
protected:
string name_;
std::string name_;
TableAxisPtr axis1_;
TableAxisPtr axis2_;
TableAxisPtr axis3_;
@ -1143,13 +1143,13 @@ public:
const LibertyPgPort *port2);
private:
string name_;
std::string name_;
PgType pg_type_;
string voltage_name_;
std::string voltage_name_;
LibertyCell *cell_;
};
string
std::string
portLibertyToSta(const char *port_name);
const char *
scanSignalTypeName(ScanSignalType scan_type);

View File

@ -32,8 +32,6 @@
namespace sta {
using std::vector;
class Units;
class Unit;
class LibertyLibrary;
@ -81,7 +79,7 @@ typedef std::shared_ptr<Table> TablePtr;
typedef std::shared_ptr<TimingArcAttrs> TimingArcAttrsPtr;
typedef std::shared_ptr<TableAxis> TableAxisPtr;
typedef std::shared_ptr<ReceiverModel> ReceiverModelPtr;
typedef vector<StatetableRow> StatetableRows;
typedef std::vector<StatetableRow> StatetableRows;
enum class ScaleFactorType : unsigned {
pin_cap,

View File

@ -32,8 +32,6 @@
namespace sta {
using std::string;
class MinMax;
class MinMaxAll;
@ -58,7 +56,7 @@ public:
static int earlyIndex() { return min_.index_; }
static int maxIndex() { return max_.index_; }
static int lateIndex() { return max_.index_; }
const string &to_string() const { return name_; }
const std::string &to_string() const { return name_; }
int index() const { return index_; }
float initValue() const { return init_value_; }
int initValueInt() const { return init_value_int_; }
@ -91,7 +89,7 @@ private:
bool (*compare)(float value1,
float value2));
const string name_;
const std::string name_;
int index_;
float init_value_;
int init_value_int_;
@ -114,7 +112,7 @@ public:
static const MinMaxAll *max() { return &max_; }
static const MinMaxAll *late() { return &max_; }
static const MinMaxAll *all() { return &all_; }
const string &to_string() const { return name_; }
const std::string &to_string() const { return name_; }
int index() const { return index_; }
const MinMax *asMinMax() const;
bool matches(const MinMax *min_max) const;
@ -131,7 +129,7 @@ private:
std::vector<const MinMax*> range,
std::vector<int> range_index);
const string name_;
const std::string name_;
int index_;
const std::vector<const MinMax*> range_;
const std::vector<int> range_index_;

View File

@ -35,8 +35,6 @@
namespace sta {
using std::function;
class Report;
class PatternMatch;
class PinVisitor;
@ -44,8 +42,8 @@ class PinVisitor;
typedef Map<const char*, LibertyLibrary*, CharPtrLess> LibertyLibraryMap;
// Link network function returns top level instance.
// Return nullptr if link fails.
typedef function<Instance* (const char *top_cell_name,
bool make_black_boxes)> LinkNetworkFunc;
typedef std::function<Instance* (const char *top_cell_name,
bool make_black_boxes)> LinkNetworkFunc;
typedef Map<const Net*, PinSet*> NetDrvrPinsMap;
// The Network class defines the network API used by sta.
@ -153,8 +151,8 @@ public:
// Filename may return null.
virtual const char *filename(const Cell *cell) = 0;
// Attributes can be null
virtual string getAttribute(const Cell *cell,
const string &key) const = 0;
virtual std::string getAttribute(const Cell *cell,
const std::string &key) const = 0;
// Name can be a simple, bundle, bus, or bus bit name.
virtual Port *findPort(const Cell *cell,
const char *name) const = 0;
@ -217,8 +215,8 @@ public:
const PatternMatch *pattern) const;
virtual InstanceSeq findInstancesHierMatching(const Instance *instance,
const PatternMatch *pattern) const;
virtual string getAttribute(const Instance *inst,
const string &key) const = 0;
virtual std::string getAttribute(const Instance *inst,
const std::string &key) const = 0;
// Hierarchical path name.
virtual const char *pathName(const Instance *instance) const;
bool pathNameLess(const Instance *inst1,
@ -559,11 +557,11 @@ public:
virtual void setIsLeaf(Cell *cell,
bool is_leaf) = 0;
virtual void setAttribute(Cell *cell,
const string &key,
const string &value) = 0;
const std::string &key,
const std::string &value) = 0;
virtual void setAttribute(Instance *instance,
const string &key,
const string &value) = 0;
const std::string &key,
const std::string &value) = 0;
virtual Port *makePort(Cell *cell,
const char *name) = 0;
virtual Port *makeBusPort(Cell *cell,

View File

@ -314,7 +314,7 @@ public:
void setCouplingCapFactor(float factor);
private:
string name_;
std::string name_;
int index_;
int index_max_;
float coupling_cap_factor_;

View File

@ -28,8 +28,6 @@
namespace sta {
using std::string;
// Return true if name is a bus.
bool
isBusName(const char *name,
@ -51,7 +49,7 @@ parseBusName(const char *name,
char escape,
// Return values.
bool &is_bus,
string &bus_name,
std::string &bus_name,
int &index);
// Allow multiple different left/right bus brackets.
void
@ -61,7 +59,7 @@ parseBusName(const char *name,
char escape,
// Return values.
bool &is_bus,
string &bus_name,
std::string &bus_name,
int &index);
// Parse a bus range, such as BUS[4:0].
@ -75,7 +73,7 @@ parseBusName(const char *name,
// Return values.
bool &is_bus,
bool &is_range,
string &bus_name,
std::string &bus_name,
int &from,
int &to,
bool &subscript_wild);
@ -90,13 +88,13 @@ parseBusName(const char *name,
// Return values.
bool &is_bus,
bool &is_range,
string &bus_name,
std::string &bus_name,
int &from,
int &to,
bool &subscript_wild);
// Insert escapes before ch1 and ch2 in token.
string
std::string
escapeChars(const char *token,
const char ch1,
const char ch2,

View File

@ -61,7 +61,7 @@ public:
bool is_enum,
const StaState *sta);
~Path();
string to_string(const StaState *sta) const;
std::string to_string(const StaState *sta) const;
bool isNull() const;
// prev_path null
void init(Vertex *vertex,
@ -122,6 +122,8 @@ public:
void checkPrevPath(const StaState *sta) const;
void checkPrevPaths(const StaState *sta) const;
static Path *vertexPath(const Path *path,
const StaState *sta);
static Path *vertexPath(const Path &path,
const StaState *sta);
static Path *vertexPath(const Vertex *vertex,

View File

@ -37,8 +37,6 @@ class MinMax;
class DcalcAnalysisPt;
class Corner;
using std::string;
class PathAnalysisPt
{
public:
@ -46,7 +44,7 @@ public:
PathAPIndex index,
const MinMax *path_min_max,
DcalcAnalysisPt *dcalc_ap);
string to_string() const;
std::string to_string() const;
Corner *corner() const { return corner_; }
PathAPIndex index() const { return index_; }
const MinMax *pathMinMax() const { return path_min_max_; }

View File

@ -40,8 +40,6 @@ class RiseFall;
class MinMax;
class ReportPath;
using std::string;
// PathEnds represent search endpoints that are either unconstrained
// or constrained by a timing check, output delay, data check,
// or path delay.

View File

@ -53,10 +53,10 @@ public:
PatternMatch(const char *pattern);
PatternMatch(const char *pattern,
const PatternMatch *inherit_from);
PatternMatch(const string &pattern,
PatternMatch(const std::string &pattern,
const PatternMatch *inherit_from);
bool match(const char *str) const;
bool match(const string &str) const;
bool match(const std::string &str) const;
bool matchNoCase(const char *str) const;
const char *pattern() const { return pattern_; }
bool isRegexp() const { return is_regexp_; }

View File

@ -34,8 +34,6 @@
namespace sta {
using std::string;
class Sta;
// Adding a new property type
@ -58,7 +56,7 @@ public:
type_clk, type_clks, type_paths, type_pwr_activity };
PropertyValue();
PropertyValue(const char *value);
PropertyValue(string &value);
PropertyValue(std::string &value);
PropertyValue(float value,
const Unit *unit);
explicit PropertyValue(bool value);

View File

@ -36,8 +36,6 @@ struct Tcl_Interp;
namespace sta {
using std::string;
// Output streams used for printing.
// This is a wrapper for all printing. It supports logging output to
// a file and redirection of command output to a file.
@ -51,7 +49,7 @@ public:
virtual void reportLine(const char *fmt, ...)
__attribute__((format (printf, 2, 3)));
virtual void reportLineString(const char *line);
virtual void reportLineString(const string &line);
virtual void reportLineString(const std::string &line);
virtual void reportBlankLine();
////////////////////////////////////////////////////////////////
@ -158,7 +156,7 @@ protected:
FILE *log_stream_;
FILE *redirect_stream_;
bool redirect_to_string_;
string redirect_string_;
std::string redirect_string_;
// Buffer to support printf style arguments.
size_t buffer_size_;
char *buffer_;

View File

@ -62,8 +62,6 @@ class Corner;
class ClockPinIterator;
class ClockIterator;
using std::vector;
typedef std::pair<const Pin*, const Clock*> PinClockPair;
class ClockInsertionkLess
@ -733,6 +731,7 @@ public:
// combinational loops when dynamic loop breaking is enabled.
void makeLoopExceptions();
void makeLoopExceptions(GraphLoop *loop);
void deleteLoopExceptions();
void makeMulticyclePath(ExceptionFrom *from,
ExceptionThruSeq *thrus,
ExceptionTo *to,
@ -793,54 +792,6 @@ public:
const WireloadSelection *wireloadSelection(const MinMax *min_max);
void setWireloadSelection(WireloadSelection *selection,
const MinMaxAll *min_max);
// Common reconvergent clock pessimism.
// TCL variable sta_crpr_enabled.
bool crprEnabled() const;
void setCrprEnabled(bool enabled);
// TCL variable sta_crpr_mode.
CrprMode crprMode() const;
void setCrprMode(CrprMode mode);
// True when analysis type is on chip variation and crpr is enabled.
bool crprActive() const;
// TCL variable sta_propagate_gated_clock_enable.
// Propagate gated clock enable arrivals.
bool propagateGatedClockEnable() const;
void setPropagateGatedClockEnable(bool enable);
// TCL variable sta_preset_clear_arcs_enabled.
// Enable search through preset/clear arcs.
bool presetClrArcsEnabled() const;
void setPresetClrArcsEnabled(bool enable);
// TCL variable sta_cond_default_arcs_enabled.
// Enable/disable default arcs when conditional arcs exist.
bool condDefaultArcsEnabled() const;
void setCondDefaultArcsEnabled(bool enabled);
bool isDisabledCondDefault(Edge *edge) const;
// TCL variable sta_internal_bidirect_instance_paths_enabled.
// Enable/disable timing from bidirect pins back into the instance.
bool bidirectInstPathsEnabled() const;
void setBidirectInstPathsEnabled(bool enabled);
// TCL variable sta_bidirect_net_paths_enabled.
// Enable/disable timing from bidirect driver pins to their own loads.
bool bidirectNetPathsEnabled() const;
void setBidirectNetPathsEnabled(bool enabled);
// TCL variable sta_recovery_removal_checks_enabled.
bool recoveryRemovalChecksEnabled() const;
void setRecoveryRemovalChecksEnabled(bool enabled);
// TCL variable sta_gated_clock_checks_enabled.
bool gatedClkChecksEnabled() const;
void setGatedClkChecksEnabled(bool enabled);
// TCL variable sta_dynamic_loop_breaking.
bool dynamicLoopBreaking() const;
void setDynamicLoopBreaking(bool enable);
// TCL variable sta_propagate_all_clocks.
bool propagateAllClocks() const;
void setPropagateAllClocks(bool prop);
// TCL var sta_clock_through_tristate_enabled.
bool clkThruTristateEnabled() const;
void setClkThruTristateEnabled(bool enable);
// TCL variable sta_input_port_default_clock.
bool useDefaultArrivalClock();
void setUseDefaultArrivalClock(bool enable);
// STA interface.
InputDelaySet *refPinInputDelays(const Pin *ref_pin) const;
@ -1071,7 +1022,6 @@ public:
const Pin *drvr,
const Pin *load);
void ensureClkHpinDisables();
bool bidirectDrvrSlewFromLoad(const Pin *pin) const;
protected:
void portMembers(const Port *port,
@ -1214,7 +1164,6 @@ protected:
const Pin *loop_prev_pin);
void makeLoopExceptionThru(const Pin *pin,
ExceptionThruSeq *thrus);
void deleteLoopExceptions();
void deleteConstraints();
InputDelay *findInputDelay(const Pin *pin,
const ClockEdge *clk_edge);
@ -1317,7 +1266,6 @@ protected:
int clk_index_;
// Default clock used for unclocked input arrivals.
Clock *default_arrival_clk_;
bool use_default_arrival_clock_;
ClockNameMap clock_name_map_;
ClockPinMap clock_pin_map_;
// Clocks on hierarchical pins are indexed by the load pins.
@ -1371,12 +1319,12 @@ protected:
// set_load port
// set_fanout_load port
// Indexed by corner_index.
vector<PortExtCapMap> port_ext_cap_maps_;
std::vector<PortExtCapMap> port_ext_cap_maps_;
// set_load net
// Indexed by corner_index.
vector<NetWireCapMap> net_wire_cap_maps_;
std::vector<NetWireCapMap> net_wire_cap_maps_;
// Indexed by corner_index.
vector<PinWireCapMap> drvr_pin_wire_cap_maps_;
std::vector<PinWireCapMap> drvr_pin_wire_cap_maps_;
NetResistanceMap net_res_map_;
PinSet disabled_pins_;
PortSet disabled_ports_;
@ -1430,19 +1378,6 @@ protected:
Wireload *wireload_[MinMax::index_count];
WireloadMode wireload_mode_;
WireloadSelection *wireload_selection_[MinMax::index_count];
bool crpr_enabled_;
CrprMode crpr_mode_;
bool pocv_enabled_;
bool propagate_gated_clock_enable_;
bool preset_clr_arcs_enabled_;
bool cond_default_arcs_enabled_;
bool bidirect_net_paths_enabled_;
bool bidirect_inst_paths_enabled_;
bool recovery_removal_checks_enabled_;
bool gated_clk_checks_enabled_;
bool clk_thru_tristate_enabled_;
bool dynamic_loop_breaking_;
bool propagate_all_clks_;
// Annotations on graph objects that are stored in constraints
// rather on the graph itself.

View File

@ -122,8 +122,6 @@ public:
class ExceptionPath;
typedef Set<ExceptionState*, ExceptionStateLess> ExceptionStateSet;
enum class CrprMode { same_pin, same_transition };
// Constraint applies to clock or data paths.
enum class PathClkOrData { clk, data };

View File

@ -54,8 +54,8 @@ public:
const PatternMatch *pattern) const override;
const char *name(const Cell *cell) const override;
string getAttribute(const Cell *cell,
const string &key) const override;
std::string getAttribute(const Cell *cell,
const std::string &key) const override;
ObjectId id(const Cell *cell) const override;
Library *library(const Cell *cell) const override;
LibertyCell *libertyCell(Cell *cell) const override;
@ -91,8 +91,8 @@ public:
bool hasMembers(const Port *port) const override;
ObjectId id(const Instance *instance) const override;
string getAttribute(const Instance *inst,
const string &key) const override;
std::string getAttribute(const Instance *inst,
const std::string &key) const override;
Instance *topInstance() const override;
Cell *cell(const Instance *instance) const override;
Instance *parent(const Instance *instance) const override;

View File

@ -70,7 +70,7 @@ typedef UnorderedSet<TagGroup*, TagGroupHash, TagGroupEqual> TagGroupSet;
typedef Map<Vertex*, Slack> VertexSlackMap;
typedef Vector<VertexSlackMap> VertexSlackMapSeq;
typedef Vector<WorstSlacks> WorstSlacksSeq;
typedef vector<DelayDbl> DelayDblSeq;
typedef std::vector<DelayDbl> DelayDblSeq;
class Search : public StaState
{
@ -629,14 +629,14 @@ protected:
// Entries in tags_ may be missing where previous filter tags were deleted.
TagIndex tag_capacity_;
std::atomic<Tag **> tags_;
vector<Tag **> tags_prev_;
std::vector<Tag **> tags_prev_;
TagIndex tag_next_;
// Holes in tags_ left by deleting filter tags.
std::vector<TagIndex> tag_free_indices_;
std::mutex tag_lock_;
TagGroupSet *tag_group_set_;
std::atomic<TagGroup **> tag_groups_;
vector<TagGroup **> tag_groups_prev_;
std::vector<TagGroup **> tag_groups_prev_;
TagGroupIndex tag_group_next_;
// Holes in tag_groups_ left by deleting filter tag groups.
std::vector<TagIndex> tag_group_free_indices_;
@ -861,11 +861,11 @@ protected:
class DynLoopSrchPred
{
public:
explicit DynLoopSrchPred(TagGroupBldr *tag_bldr);
DynLoopSrchPred(TagGroupBldr *tag_bldr);
protected:
bool loopEnabled(Edge *edge,
const Sdc *sdc,
bool dynamic_loop_breaking_enabled,
const Graph *graph,
Search *search);
bool hasPendingLoopPaths(Edge *edge,

View File

@ -119,7 +119,7 @@ typedef UnorderedMap<Tag*, size_t, TagMatchHash, TagMatchEqual> PathIndexMap;
typedef Vector<Slack> SlackSeq;
typedef Delay Crpr;
typedef Vector<Path*> PathSeq;
typedef vector<const Path*> ConstPathSeq;
typedef std::vector<const Path*> ConstPathSeq;
enum class ReportPathFormat { full,
full_clock,

View File

@ -55,10 +55,8 @@ enum class StateInternalValue {
class StatetableRow;
using std::vector;
typedef vector<StateInputValue> StateInputValues;
typedef vector<StateInternalValue> StateInternalValues;
typedef std::vector<StateInputValue> StateInputValues;
typedef std::vector<StateInternalValue> StateInternalValues;
// Register/Latch
class Sequential

View File

@ -38,14 +38,12 @@
#include "PowerClass.hh"
#include "ArcDelayCalc.hh"
#include "CircuitSim.hh"
#include "Variables.hh"
struct Tcl_Interp;
namespace sta {
using std::string;
using ::Tcl_Interp;
// Don't include headers to minimize dependencies.
class MinMax;
class MinMaxAll;
@ -436,8 +434,6 @@ public:
void removeDisable(TimingArcSet *arc_set);
// Edge is disabled by constant.
bool isDisabledConstant(Edge *edge);
// Edge is default cond disabled by timing_disable_cond_default_arcs var.
bool isDisabledCondDefault(Edge *edge);
// Return a set of constant pins that disabled edge.
// Caller owns the returned set.
PinSet disabledConstantPins(Edge *edge);
@ -793,61 +789,7 @@ public:
bool no_version);
// Remove all delay and slew annotations.
void removeDelaySlewAnnotations();
// TCL variable sta_crpr_enabled.
// Common Reconvergent Clock Removal (CRPR).
// Timing check source/target common clock path overlap for search
// with analysis mode on_chip_variation.
bool crprEnabled() const;
void setCrprEnabled(bool enabled);
// TCL variable sta_crpr_mode.
CrprMode crprMode() const;
void setCrprMode(CrprMode mode);
// TCL variable sta_pocv_enabled.
// Parametric on chip variation (statisical sta).
bool pocvEnabled() const;
void setPocvEnabled(bool enabled);
// Number of std deviations from mean to use for normal distributions.
void setSigmaFactor(float factor);
// TCL variable sta_propagate_gated_clock_enable.
// Propagate gated clock enable arrivals.
bool propagateGatedClockEnable() const;
void setPropagateGatedClockEnable(bool enable);
// TCL variable sta_preset_clear_arcs_enabled.
// Enable search through preset/clear arcs.
bool presetClrArcsEnabled() const;
void setPresetClrArcsEnabled(bool enable);
// TCL variable sta_cond_default_arcs_enabled.
// Enable/disable default arcs when conditional arcs exist.
bool condDefaultArcsEnabled() const;
void setCondDefaultArcsEnabled(bool enabled);
// TCL variable sta_internal_bidirect_instance_paths_enabled.
// Enable/disable timing from bidirect pins back into the instance.
bool bidirectInstPathsEnabled() const;
void setBidirectInstPathsEnabled(bool enabled);
// TCL variable sta_bidirect_net_paths_enabled.
// Enable/disable timing from bidirect driver pins to their own loads.
bool bidirectNetPathsEnabled() const;
void setBidirectNetPathsEnabled(bool enabled);
// TCL variable sta_recovery_removal_checks_enabled.
bool recoveryRemovalChecksEnabled() const;
void setRecoveryRemovalChecksEnabled(bool enabled);
// TCL variable sta_gated_clock_checks_enabled.
bool gatedClkChecksEnabled() const;
void setGatedClkChecksEnabled(bool enabled);
// TCL variable sta_dynamic_loop_breaking.
bool dynamicLoopBreaking() const;
void setDynamicLoopBreaking(bool enable);
// TCL variable sta_propagate_all_clocks.
// Clocks defined after sta_propagate_all_clocks is true
// are propagated (existing clocks are not effected).
bool propagateAllClocks() const;
void setPropagateAllClocks(bool prop);
// TCL var sta_clock_through_tristate_enabled.
bool clkThruTristateEnabled() const;
void setClkThruTristateEnabled(bool enable);
// TCL variable sta_input_port_default_clock.
bool useDefaultArrivalClock() const;
void setUseDefaultArrivalClock(bool enable);
virtual CheckErrorSeq &checkTiming(bool no_input_delay,
bool no_output_delay,
bool reg_multiple_clks,
@ -1178,7 +1120,9 @@ public:
bool includes_pin_caps,
const ParasiticAnalysisPt *ap);
////////////////////////////////////////////////////////////////
// TCL network edit function support.
virtual Instance *makeInstance(const char *name,
LibertyCell *cell,
Instance *parent);
@ -1322,10 +1266,71 @@ public:
const char *gnd_name,
CircuitSim ckt_sim);
////////////////////////////////////////////////////////////////
// TCL Variables
// TCL variable sta_crpr_enabled.
// Common Reconvergent Clock Removal (CRPR).
// Timing check source/target common clock path overlap for search
// with analysis mode on_chip_variation.
bool crprEnabled() const;
void setCrprEnabled(bool enabled);
// TCL variable sta_crpr_mode.
CrprMode crprMode() const;
void setCrprMode(CrprMode mode);
// TCL variable sta_pocv_enabled.
// Parametric on chip variation (statisical sta).
bool pocvEnabled() const;
void setPocvEnabled(bool enabled);
// Number of std deviations from mean to use for normal distributions.
void setSigmaFactor(float factor);
// TCL variable sta_propagate_gated_clock_enable.
// Propagate gated clock enable arrivals.
bool propagateGatedClockEnable() const;
void setPropagateGatedClockEnable(bool enable);
// TCL variable sta_preset_clear_arcs_enabled.
// Enable search through preset/clear arcs.
bool presetClrArcsEnabled() const;
void setPresetClrArcsEnabled(bool enable);
// TCL variable sta_cond_default_arcs_enabled.
// Enable/disable default arcs when conditional arcs exist.
bool condDefaultArcsEnabled() const;
void setCondDefaultArcsEnabled(bool enabled);
// TCL variable sta_internal_bidirect_instance_paths_enabled.
// Enable/disable timing from bidirect pins back into the instance.
bool bidirectInstPathsEnabled() const;
void setBidirectInstPathsEnabled(bool enabled);
// TCL variable sta_bidirect_net_paths_enabled.
// Enable/disable timing from bidirect driver pins to their own loads.
bool bidirectNetPathsEnabled() const;
void setBidirectNetPathsEnabled(bool enabled);
// TCL variable sta_recovery_removal_checks_enabled.
bool recoveryRemovalChecksEnabled() const;
void setRecoveryRemovalChecksEnabled(bool enabled);
// TCL variable sta_gated_clock_checks_enabled.
bool gatedClkChecksEnabled() const;
void setGatedClkChecksEnabled(bool enabled);
// TCL variable sta_dynamic_loop_breaking.
bool dynamicLoopBreaking() const;
void setDynamicLoopBreaking(bool enable);
// TCL variable sta_propagate_all_clocks.
// Clocks defined after sta_propagate_all_clocks is true
// are propagated (existing clocks are not effected).
bool propagateAllClocks() const;
void setPropagateAllClocks(bool prop);
// TCL var sta_clock_through_tristate_enabled.
bool clkThruTristateEnabled() const;
void setClkThruTristateEnabled(bool enable);
// TCL variable sta_input_port_default_clock.
bool useDefaultArrivalClock() const;
void setUseDefaultArrivalClock(bool enable);
////////////////////////////////////////////////////////////////
protected:
// Default constructors that are called by makeComponents in the Sta
// constructor. These can be redefined by a derived class to
// specialize the sta components.
virtual void makeVariables();
virtual void makeReport();
virtual void makeDebug();
virtual void makeUnits();

View File

@ -35,6 +35,7 @@ class NetworkReader;
class Sdc;
class Corners;
class Graph;
class Edge;
class Levelize;
class Sim;
class Search;
@ -44,6 +45,7 @@ class GraphDelayCalc;
class Latches;
class ClkNetwork;
class DispatchQueue;
class Variables;
// Most STA components use functionality in other components.
// This class simplifies the process of copying pointers to the
@ -54,7 +56,7 @@ class StaState
public:
// Make an empty state.
StaState();
explicit StaState(const StaState *sta);
StaState(const StaState *sta);
// Copy the state from sta. This is virtual so that a component
// can notify sub-components.
virtual void copyState(const StaState *sta);
@ -102,8 +104,12 @@ public:
ClkNetwork *clkNetwork() { return clk_network_; }
ClkNetwork *clkNetwork() const { return clk_network_; }
unsigned threadCount() const { return thread_count_; }
bool pocvEnabled() const { return pocv_enabled_; }
float sigmaFactor() const { return sigma_factor_; }
bool crprActive() const;
Variables *variables() { return variables_; }
const Variables *variables() const { return variables_; }
// Edge is default cond disabled by timing_disable_cond_default_arcs var.
bool isDisabledCondDefault(Edge *edge) const;
protected:
Report *report_;
@ -124,9 +130,9 @@ protected:
Search *search_;
Latches *latches_;
ClkNetwork *clk_network_;
Variables *variables_;
int thread_count_;
DispatchQueue *dispatch_queue_;
bool pocv_enabled_;
float sigma_factor_;
};

View File

@ -31,7 +31,7 @@
namespace sta {
typedef Set<const char*, CharPtrLess> StringSet;
typedef std::set<string> StdStringSet;
typedef std::set<std::string> StdStringSet;
void
deleteContents(StringSet *strings);

View File

@ -33,8 +33,6 @@
namespace sta {
using std::string;
inline bool
stringEq(const char *str1,
const char *str2)
@ -167,19 +165,19 @@ isDigits(const char *str);
char *
stringPrint(const char *fmt,
...) __attribute__((format (printf, 1, 2)));
string
std::string
stdstrPrint(const char *fmt,
...) __attribute__((format (printf, 1, 2)));
char *
stringPrintArgs(const char *fmt,
va_list args);
void
stringPrint(string &str,
stringPrint(std::string &str,
const char *fmt,
...) __attribute__((format (printf, 2, 3)));
// Formated append to std::string.
void
stringAppend(string &str,
stringAppend(std::string &str,
const char *fmt,
...) __attribute__((format (printf, 2, 3)));
@ -191,7 +189,7 @@ stringPrintTmp(const char *fmt,
char *
makeTmpString(size_t length);
char *
makeTmpString(string &str);
makeTmpString(std::string &str);
bool
isTmpString(const char *str);
@ -199,13 +197,13 @@ isTmpString(const char *str);
// Trim right spaces.
void
trimRight(string &str);
trimRight(std::string &str);
typedef Vector<string> StringVector;
typedef Vector<std::string> StringVector;
void
split(const string &text,
const string &delims,
split(const std::string &text,
const std::string &delims,
// Return values.
StringVector &tokens);

View File

@ -35,8 +35,6 @@
namespace sta {
using std::string;
class Unit;
class Units;
class Report;

View File

@ -33,7 +33,7 @@ namespace sta {
class TimingRole;
typedef std::map<string, const TimingRole*> TimingRoleMap;
typedef std::map<std::string, const TimingRole*> TimingRoleMap;
class TimingRole
{
@ -68,7 +68,7 @@ public:
static const TimingRole *nonSeqHold() { return &non_seq_hold_; }
static const TimingRole *clockTreePathMin() { return &clock_tree_path_min_; }
static const TimingRole *clockTreePathMax() { return &clock_tree_path_max_; }
const string &to_string() const { return name_; }
const std::string &to_string() const { return name_; }
int index() const { return index_; }
bool isWire() const;
bool isTimingCheck() const { return is_timing_check_; }
@ -101,7 +101,7 @@ private:
const TimingRole *generic_role,
int index);
const string name_;
const std::string name_;
bool is_timing_check_;
bool is_sdf_iopath_;
bool is_non_seq_check_;

View File

@ -37,7 +37,7 @@ class Transition;
class RiseFall;
class RiseFallBoth;
typedef Map<const string, const Transition*> TransitionMap;
typedef Map<const std::string, const Transition*> TransitionMap;
// Rise/fall transition.
class RiseFall
@ -48,7 +48,7 @@ public:
static const RiseFall *fall() { return &fall_; }
static int riseIndex() { return rise_.sdf_triple_index_; }
static int fallIndex() { return fall_.sdf_triple_index_; }
const string &to_string() const { return short_name_; }
const std::string &to_string() const { return short_name_; }
const char *name() const { return name_.c_str(); }
const char *shortName() const { return short_name_.c_str(); }
int index() const { return sdf_triple_index_; }
@ -75,8 +75,8 @@ protected:
const char *short_name,
int sdf_triple_index);
const string name_;
const string short_name_;
const std::string name_;
const std::string short_name_;
const int sdf_triple_index_;
static const RiseFall rise_;
@ -93,7 +93,7 @@ public:
static const RiseFallBoth *rise() { return &rise_; }
static const RiseFallBoth *fall() { return &fall_; }
static const RiseFallBoth *riseFall() { return &rise_fall_; }
const string &to_string() const { return short_name_; }
const std::string &to_string() const { return short_name_; }
const char *name() const { return name_.c_str(); }
const char *shortName() const { return short_name_.c_str(); }
int index() const { return sdf_triple_index_; }
@ -119,8 +119,8 @@ protected:
std::vector<const RiseFall*> range,
std::vector<int> range_index);
const string name_;
const string short_name_;
const std::string name_;
const std::string short_name_;
const int sdf_triple_index_;
const RiseFall *as_rise_fall_;
const std::vector<const RiseFall*> range_;
@ -150,7 +150,7 @@ public:
static const Transition *trZX() { return &tr_ZX_; }
// Matches rise and fall.
static const Transition *riseFall() { return &rise_fall_; }
const string &to_string() const { return name_; }
const std::string &to_string() const { return name_; }
// As initial/final value pair.
const char *asInitFinalString() const { return init_final_.c_str(); }
int sdfTripleIndex() const { return sdf_triple_index_; }
@ -168,8 +168,8 @@ private:
const RiseFall *as_rise_fall,
int sdf_triple_index);
const string name_;
const string init_final_;
const std::string name_;
const std::string init_final_;
const RiseFall *as_rise_fall_;
const int sdf_triple_index_;

View File

@ -28,8 +28,6 @@
namespace sta {
using std::string;
class Unit
{
public:
@ -62,8 +60,8 @@ private:
void setScaledSuffix();
float scale_; // multiplier from user units to internal units
string suffix_; // print suffix
string scaled_suffix_;
std::string suffix_; // print suffix
std::string scaled_suffix_;
int digits_; // print digits (after decimal pt)
};

98
include/sta/Variables.hh Normal file
View File

@ -0,0 +1,98 @@
// OpenSTA, Static Timing Analyzer
// Copyright (c) 2025, Parallax Software, Inc.
//
// 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 3 of the License, or
// (at your option) any later version.
//
// This program 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 General Public License for more details.
//
// You should have received a copy of the GNU General Public License
// along with this program. If not, see <https://www.gnu.org/licenses/>.
//
// The origin of this software must not be misrepresented; you must not
// claim that you wrote the original software.
//
// Altered source versions must be plainly marked as such, and must not be
// misrepresented as being the original software.
//
// This notice may not be removed or altered from any source distribution.
#pragma once
namespace sta {
enum class CrprMode { same_pin, same_transition };
// TCL Variables
class Variables
{
public:
Variables();
// TCL variable sta_propagate_gated_clock_enable.
bool crprEnabled() const { return crpr_enabled_; }
void setCrprEnabled(bool enabled);
CrprMode crprMode() const { return crpr_mode_; }
void setCrprMode(CrprMode mode);
// Propagate gated clock enable arrivals.
bool propagateGatedClockEnable() const { return propagate_gated_clock_enable_; }
void setPropagateGatedClockEnable(bool enable);
// TCL variable sta_preset_clear_arcs_enabled.
// Enable search through preset/clear arcs.
bool presetClrArcsEnabled() const { return preset_clr_arcs_enabled_; }
void setPresetClrArcsEnabled(bool enable);
// TCL variable sta_cond_default_arcs_enabled.
// Enable/disable default arcs when conditional arcs exist.
bool condDefaultArcsEnabled() const { return cond_default_arcs_enabled_; }
void setCondDefaultArcsEnabled(bool enabled);
// TCL variable sta_internal_bidirect_instance_paths_enabled.
// Enable/disable timing from bidirect pins back into the instance.
bool bidirectInstPathsEnabled() const { return bidirect_inst_paths_enabled_; }
void setBidirectInstPathsEnabled(bool enabled);
// TCL variable sta_bidirect_net_paths_enabled.
// Enable/disable timing from bidirect driver pins to their own loads.
bool bidirectNetPathsEnabled() const { return bidirect_net_paths_enabled_; }
void setBidirectNetPathsEnabled(bool enabled);
// TCL variable sta_recovery_removal_checks_enabled.
bool recoveryRemovalChecksEnabled() const { return recovery_removal_checks_enabled_; }
void setRecoveryRemovalChecksEnabled(bool enabled);
// TCL variable sta_gated_clock_checks_enabled.
bool gatedClkChecksEnabled() const { return gated_clk_checks_enabled_; }
void setGatedClkChecksEnabled(bool enabled);
// TCL variable sta_dynamic_loop_breaking.
bool dynamicLoopBreaking() const { return dynamic_loop_breaking_; }
void setDynamicLoopBreaking(bool enable);
// TCL variable sta_propagate_all_clocks.
bool propagateAllClocks() const { return propagate_all_clks_; }
void setPropagateAllClocks(bool prop);
// TCL var sta_clock_through_tristate_enabled.
bool clkThruTristateEnabled() const { return clk_thru_tristate_enabled_; }
void setClkThruTristateEnabled(bool enable);
// TCL variable sta_input_port_default_clock.
bool useDefaultArrivalClock() { return use_default_arrival_clock_; }
void setUseDefaultArrivalClock(bool enable);
bool pocvEnabled() const { return pocv_enabled_; }
void setPocvEnabled(bool enabled);
private:
bool crpr_enabled_;
CrprMode crpr_mode_;
bool propagate_gated_clock_enable_;
bool preset_clr_arcs_enabled_;
bool cond_default_arcs_enabled_;
bool bidirect_net_paths_enabled_;
bool bidirect_inst_paths_enabled_;
bool recovery_removal_checks_enabled_;
bool gated_clk_checks_enabled_;
bool clk_thru_tristate_enabled_;
bool dynamic_loop_breaking_;
bool propagate_all_clks_;
bool use_default_arrival_clock_;
bool pocv_enabled_;
};
} // namespace

View File

@ -28,24 +28,22 @@
namespace sta {
using std::string;
string
std::string
cellVerilogName(const char *sta_name);
string
std::string
instanceVerilogName(const char *sta_name);
string
std::string
netVerilogName(const char *sta_name);
string
std::string
portVerilogName(const char *sta_name);
string
moduleVerilogToSta(const string *sta_name);
string
instanceVerilogToSta(const string *sta_name);
string
netVerilogToSta(const string *sta_name);
string
portVerilogToSta(const string *sta_name);
std::string
moduleVerilogToSta(const std::string *sta_name);
std::string
instanceVerilogToSta(const std::string *sta_name);
std::string
netVerilogToSta(const std::string *sta_name);
std::string
portVerilogToSta(const std::string *sta_name);
} // namespace

View File

@ -70,10 +70,6 @@ typedef Vector<VerilogAttrStmt*> VerilogAttrStmtSeq;
typedef Vector<VerilogAttrEntry*> VerilogAttrEntrySeq;
typedef Vector<VerilogError*> VerilogErrorSeq;
using std::string;
using std::vector;
using std::set;
class VerilogReader
{
public:
@ -81,12 +77,12 @@ public:
~VerilogReader();
bool read(const char *filename);
void makeModule(const string *module_name,
void makeModule(const std::string *module_name,
VerilogNetSeq *ports,
VerilogStmtSeq *stmts,
VerilogAttrStmtSeq *attr_stmts,
int line);
void makeModule(const string *module_name,
void makeModule(const std::string *module_name,
VerilogStmtSeq *port_dcls,
VerilogStmtSeq *stmts,
VerilogAttrStmtSeq *attr_stmts,
@ -99,7 +95,7 @@ public:
VerilogDclArg *arg,
VerilogAttrStmtSeq *attr_stmts,
int line);
VerilogDclArg *makeDclArg(const string *net_name);
VerilogDclArg *makeDclArg(const std::string *net_name);
VerilogDclArg*makeDclArg(VerilogAssign *assign);
VerilogDclBus *makeDclBus(PortDirection *dir,
int from_index,
@ -113,36 +109,36 @@ public:
VerilogDclArgSeq *args,
VerilogAttrStmtSeq *attr_stmts,
int line);
VerilogInst *makeModuleInst(const string *module_name,
const string *inst_name,
VerilogInst *makeModuleInst(const std::string *module_name,
const std::string *inst_name,
VerilogNetSeq *pins,
VerilogAttrStmtSeq *attr_stmts,
const int line);
VerilogAssign *makeAssign(VerilogNet *lhs,
VerilogNet *rhs,
int line);
VerilogNetScalar *makeNetScalar(const string *name);
VerilogNetPortRef *makeNetNamedPortRefScalarNet(const string *port_vname);
VerilogNetPortRef *makeNetNamedPortRefScalarNet(const string *port_name,
const string *net_name);
VerilogNetPortRef *makeNetNamedPortRefBitSelect(const string *port_name,
const string *bus_name,
VerilogNetScalar *makeNetScalar(const std::string *name);
VerilogNetPortRef *makeNetNamedPortRefScalarNet(const std::string *port_vname);
VerilogNetPortRef *makeNetNamedPortRefScalarNet(const std::string *port_name,
const std::string *net_name);
VerilogNetPortRef *makeNetNamedPortRefBitSelect(const std::string *port_name,
const std::string *bus_name,
int index);
VerilogNetPortRef *makeNetNamedPortRefScalar(const string *port_name,
VerilogNetPortRef *makeNetNamedPortRefScalar(const std::string *port_name,
VerilogNet *net);
VerilogNetPortRef *makeNetNamedPortRefBit(const string *port_name,
VerilogNetPortRef *makeNetNamedPortRefBit(const std::string *port_name,
int index,
VerilogNet *net);
VerilogNetPortRef *makeNetNamedPortRefPart(const string *port_name,
VerilogNetPortRef *makeNetNamedPortRefPart(const std::string *port_name,
int from_index,
int to_index,
VerilogNet *net);
VerilogNetConcat *makeNetConcat(VerilogNetSeq *nets);
VerilogNetConstant *makeNetConstant(const string *constant,
VerilogNetConstant *makeNetConstant(const std::string *constant,
int line);
VerilogNetBitSelect *makeNetBitSelect(const string *name,
VerilogNetBitSelect *makeNetBitSelect(const std::string *name,
int index);
VerilogNetPartSelect *makeNetPartSelect(const string *name,
VerilogNetPartSelect *makeNetPartSelect(const std::string *name,
int from_index,
int to_index);
VerilogModule *module(Cell *cell);
@ -160,11 +156,11 @@ public:
const char *filename,
int line,
const char *fmt, ...);
const string &zeroNetName() const { return zero_net_name_; }
const string &oneNetName() const { return one_net_name_; }
const std::string &zeroNetName() const { return zero_net_name_; }
const std::string &oneNetName() const { return one_net_name_; }
void deleteModules();
void reportStmtCounts();
const string &constant10Max() const { return constant10_max_; }
const std::string &constant10Max() const { return constant10_max_; }
protected:
void init(const char *filename);
@ -173,13 +169,13 @@ protected:
VerilogNetSeq *ports);
Port *makeCellPort(Cell *cell,
VerilogModule *module,
const string &port_name);
const std::string &port_name);
void makeNamedPortRefCellPorts(Cell *cell,
VerilogModule *module,
VerilogNet *mod_port,
StdStringSet &port_names);
void checkModuleDcls(VerilogModule *module,
set<string> &port_names);
std::set<std::string> &port_names);
void makeModuleInstBody(VerilogModule *module,
Instance *inst,
VerilogBindingTbl *bindings,
@ -230,7 +226,7 @@ protected:
bool is_leaf);
void makeInstPin(Instance *inst,
Port *port,
const string &net_name,
const std::string &net_name,
VerilogBindingTbl *bindings,
Instance *parent,
VerilogBindingTbl *parent_bindings,
@ -259,7 +255,7 @@ protected:
bool hasScalarNamedPortRefs(LibertyCell *liberty_cell,
VerilogNetSeq *pins);
string filename_;
std::string filename_;
Report *report_;
Debug *debug_;
NetworkReader *network_;
@ -268,9 +264,9 @@ protected:
int black_box_index_;
VerilogModuleMap module_map_;
VerilogErrorSeq link_errors_;
const string zero_net_name_;
const string one_net_name_;
string constant10_max_;
const std::string zero_net_name_;
const std::string one_net_name_;
std::string constant10_max_;
ViewType *view_type_;
bool report_stmt_stats_;
int module_count_;

View File

@ -30,6 +30,8 @@
namespace sta {
using std::string;
FuncExpr *
FuncExpr::makePort(LibertyPort *port)
{

View File

@ -37,7 +37,7 @@
#pragma GCC diagnostic ignored "-Wunused-but-set-variable"
void
sta::LibExprParse::error(const string &msg)
sta::LibExprParse::error(const std::string &msg)
{
reader->parseError(msg.c_str());
}

View File

@ -42,7 +42,7 @@ parseFuncExpr(const char *func,
Report *report)
{
if (func != nullptr && func[0] != '\0') {
string func1(func);
std::string func1(func);
std::istringstream stream(func);
LibExprReader reader(func, cell, error_msg, report);
LibExprScanner scanner(stream);

View File

@ -36,8 +36,6 @@
namespace sta {
using std::string;
class Report;
class LibExprParse;
@ -56,7 +54,7 @@ public:
private:
Report *report_;
string token_;
std::string token_;
};
} // namespace

View File

@ -39,7 +39,7 @@
void
sta::LibertyParse::error(const location_type &loc,
const string &msg)
const std::string &msg)
{
reader->report()->fileError(164, reader->filename().c_str(),
loc.begin.line, "%s", msg.c_str());

View File

@ -36,6 +36,8 @@
namespace sta {
using std::string;
void
parseLibertyFile(const char *filename,
LibertyGroupVisitor *library_visitor,

View File

@ -48,11 +48,11 @@ class LibertyScanner;
typedef Vector<LibertyStmt*> LibertyStmtSeq;
typedef Vector<LibertyGroup*> LibertyGroupSeq;
typedef Vector<LibertyAttr*> LibertyAttrSeq;
typedef Map<string, LibertyAttr*> LibertyAttrMap;
typedef Map<string, LibertyDefine*> LibertyDefineMap;
typedef Map<std::string, LibertyAttr*> LibertyAttrMap;
typedef Map<std::string, LibertyDefine*> LibertyDefineMap;
typedef Vector<LibertyAttrValue*> LibertyAttrValueSeq;
typedef Map<string, float> LibertyVariableMap;
typedef Map<string, LibertyGroupVisitor*>LibertyGroupVisitorMap;
typedef Map<std::string, float> LibertyVariableMap;
typedef Map<std::string, LibertyGroupVisitor*>LibertyGroupVisitorMap;
typedef LibertyAttrValueSeq::Iterator LibertyAttrValueIterator;
typedef Vector<LibertyGroup*> LibertyGroupSeq;
@ -67,8 +67,8 @@ public:
LibertyParser(const char *filename,
LibertyGroupVisitor *library_visitor,
Report *report);
const string &filename() const { return filename_; }
void setFilename(const string &filename);
const std::string &filename() const { return filename_; }
void setFilename(const std::string &filename);
Report *report() const { return report_; }
LibertyStmt *makeDefine(LibertyAttrValueSeq *values,
int line);
@ -93,7 +93,7 @@ public:
int line);
private:
string filename_;
std::string filename_;
LibertyGroupVisitor *group_visitor_;
Report *report_;
LibertyGroupSeq group_stack_;
@ -143,7 +143,7 @@ public:
protected:
void parseNames(LibertyAttrValueSeq *values);
string type_;
std::string type_;
LibertyAttrValueSeq *params_;
LibertyAttrSeq *attrs_;
LibertyAttrMap *attr_map_;
@ -177,7 +177,7 @@ public:
virtual LibertyAttrValue *firstValue() = 0;
protected:
string name_;
std::string name_;
};
// Abstract base class for simple attributes.
@ -239,7 +239,7 @@ public:
virtual const char *stringValue();
private:
string value_;
std::string value_;
};
class LibertyFloatAttrValue : public LibertyAttrValue
@ -272,7 +272,7 @@ public:
LibertyAttrType valueType() const { return value_type_; }
private:
string name_;
std::string name_;
LibertyGroupType group_type_;
LibertyAttrType value_type_;
};
@ -292,7 +292,7 @@ public:
float value() const { return value_; }
private:
string var_;
std::string var_;
float value_;
};

View File

@ -2775,6 +2775,7 @@ LibertyReader::endVector(LibertyGroup *group)
if (!reference_time_exists_)
libWarn(1224, group->line(), "vector reference_time not found.");
reference_time_exists_ = false;
tbl_template_ = nullptr;
}
}

View File

@ -60,8 +60,6 @@ class TimingArcBuilder;
class LibertyAttr;
class OutputWaveform;
using std::vector;
typedef void (LibertyReader::*LibraryAttrVisitor)(LibertyAttr *attr);
typedef void (LibertyReader::*LibraryGroupVisitor)(LibertyGroup *group);
typedef Map<string, LibraryAttrVisitor> LibraryAttrMap;
@ -74,7 +72,7 @@ typedef Vector<InternalPowerGroup*> InternalPowerGroupSeq;
typedef Vector<LeakagePowerGroup*> LeakagePowerGroupSeq;
typedef void (LibertyPort::*LibertyPortBoolSetter)(bool value);
typedef Vector<OutputWaveform*> OutputWaveformSeq;
typedef vector<string> StdStringSeq;
typedef std::vector<std::string> StdStringSeq;
class LibertyReader : public LibertyGroupVisitor
{

View File

@ -61,13 +61,13 @@ private:
void error(const char *msg);
std::istream *stream_;
string filename_;
std::string filename_;
LibertyParser *reader_;
Report *report_;
string token_;
std::string token_;
// Previous lex state for include files.
string filename_prev_;
std::string filename_prev_;
std::istream *stream_prev_;
};

View File

@ -34,6 +34,7 @@
namespace sta {
using std::string;
using std::map;
using std::min;
using std::max;

View File

@ -33,6 +33,8 @@
namespace sta {
using std::string;
static void
makeChildNetwork(Instance *proto,
Instance *parent,

View File

@ -34,6 +34,8 @@
namespace sta {
using std::string;
Network::Network() :
default_liberty_(nullptr),
divider_('/'),

View File

@ -30,6 +30,7 @@
namespace sta {
using std::string;
using std::to_string;
static string

View File

@ -31,6 +31,8 @@
namespace sta {
using std::string;
constexpr char verilog_escape = '\\';
static string

View File

@ -39,7 +39,7 @@
void
sta::SpefParse::error(const location_type &loc,
const string &msg)
const std::string &msg)
{
reader->report()->fileError(164,reader->filename(),
loc.begin.line,"%s",msg.c_str());

View File

@ -41,9 +41,7 @@ class SpefTriple;
class Corner;
class SpefScanner;
using std::string;
typedef std::map<int, string> SpefNameMap;
typedef std::map<int, std::string> SpefNameMap;
class SpefReader : public StaState
{

View File

@ -41,7 +41,7 @@ class SpefScanner : public SpefFlexLexer
{
public:
SpefScanner(std::istream *stream,
const string &filename,
const std::string &filename,
SpefReader *reader,
Report *report);
virtual ~SpefScanner() {}
@ -58,10 +58,10 @@ public:
using FlexLexer::yylex;
private:
string filename_;
std::string filename_;
SpefReader *reader_;
Report *report_;
string token_;
std::string token_;
};
} // namespace

View File

@ -74,6 +74,8 @@ using std::abs;
using std::max;
using std::min;
using std::isnormal;
using std::vector;
using std::map;
static bool
isPositiveUnate(const LibertyCell *cell,
@ -942,7 +944,7 @@ Power::getMinRfSlew(const Pin *pin)
if (delayGreater(slew, mm_slew, min_max, this))
mm_slew = slew;
}
return mm_slew;
return delayAsFloat(mm_slew);
}
return 0.0;
}

View File

@ -40,7 +40,7 @@
void
sta::SaifParse::error(const location_type &loc,
const string &msg)
const std::string &msg)
{
reader->report()->fileError(169,reader->filename(),loc.begin.line,"%s",msg.c_str());
}

View File

@ -131,7 +131,7 @@ SaifReader::instancePush(const char *instance_name)
bool first = true;
for (string &inst : saif_scope_) {
if (!first)
saif_scope += network_->pathDivider();
saif_scope += sdc_network_->pathDivider();
saif_scope += inst;
first = false;
}
@ -140,8 +140,8 @@ SaifReader::instancePush(const char *instance_name)
}
else {
// Inside annotation scope.
Instance *parent = path_.empty() ? network_->topInstance() : path_.back();
Instance *child = network_->findChild(parent, instance_name);
Instance *parent = path_.empty() ? sdc_network_->topInstance() : path_.back();
Instance *child = sdc_network_->findChild(parent, instance_name);
path_.push_back(child);
}
stringDelete(instance_name);
@ -163,7 +163,7 @@ SaifReader::setNetDurations(const char *net_name,
SaifStateDurations &durations)
{
if (in_scope_level_ > 0) {
Instance *parent = path_.empty() ? network_->topInstance() : path_.back();
Instance *parent = path_.empty() ? sdc_network_->topInstance() : path_.back();
if (parent) {
string unescaped_name = unescaped(net_name);
const Pin *pin = sdc_network_->findPin(parent, unescaped_name.c_str());
@ -196,9 +196,7 @@ SaifReader::unescaped(const char *token)
string unescaped;
for (const char *t = token; *t; t++) {
char ch = *t;
if (ch == escape_)
unescaped += *(t+1);
else
if (ch != escape_)
// Just the normal noises.
unescaped += ch;
}

View File

@ -45,9 +45,6 @@ class Sta;
class Power;
class SaifScanner;
using std::vector;
using std::string;
enum class SaifState { T0, T1, TX, TZ, TB, TC, IG };
typedef std::array<uint64_t, static_cast<int>(SaifState::IG)+1> SaifStateDurations;
@ -71,7 +68,7 @@ public:
const char *filename() { return filename_; }
private:
string unescaped(const char *token);
std::string unescaped(const char *token);
const char *filename_;
const char *scope_; // Divider delimited scope to begin annotation.
@ -81,9 +78,9 @@ private:
double timescale_;
int64_t duration_;
vector<string> saif_scope_; // Scope during parsing.
std::vector<std::string> saif_scope_; // Scope during parsing.
size_t in_scope_level_;
vector<Instance*> path_; // Path within scope.
std::vector<Instance*> path_; // Path within scope.
std::set<const Pin*> annotated_pins_;
Power *power_;
};

View File

@ -41,7 +41,7 @@ class SaifScanner : public SaifFlexLexer
{
public:
SaifScanner(std::istream *stream,
const string &filename,
const std::string &filename,
SaifReader *reader,
Report *report);
virtual ~SaifScanner() {}
@ -57,10 +57,10 @@ public:
using FlexLexer::yylex;
private:
string filename_;
std::string filename_;
SaifReader *reader_;
Report *report_;
string token_;
std::string token_;
};
} // namespace

View File

@ -34,6 +34,8 @@
namespace sta {
using std::vector;
using std::string;
using std::isspace;
// Very imprecise syntax definition
@ -52,7 +54,7 @@ VcdParse::read(const char *filename,
reader_ = reader;
file_line_ = 1;
stmt_line_ = 1;
string token = getToken();
std::string token = getToken();
while (!token.empty()) {
if (token == "$date")
reader_->setDate(readStmtString());

View File

@ -33,11 +33,8 @@
namespace sta {
using std::string;
using std::vector;
typedef int64_t VcdTime;
typedef vector<string> VcdScope;
typedef std::vector<std::string> VcdScope;
enum class VcdVarType {
wire,
@ -71,19 +68,19 @@ public:
private:
void parseTimescale();
void setTimeUnit(const string &time_unit,
void setTimeUnit(const std::string &time_unit,
double time_scale);
void parseVar();
void parseScope();
void parseUpscope();
void parseVarValues();
string getToken();
string readStmtString();
vector<string> readStmtTokens();
std::string getToken();
std::string readStmtString();
std::vector<std::string> readStmtTokens();
VcdReader *reader_;
gzFile stream_;
string token_;
std::string token_;
const char *filename_;
int file_line_;
int stmt_line_;
@ -101,24 +98,24 @@ class VcdReader
{
public:
virtual ~VcdReader() {}
virtual void setDate(const string &date) = 0;
virtual void setComment(const string &comment) = 0;
virtual void setVersion(const string &version) = 0;
virtual void setTimeUnit(const string &time_unit,
virtual void setDate(const std::string &date) = 0;
virtual void setComment(const std::string &comment) = 0;
virtual void setVersion(const std::string &version) = 0;
virtual void setTimeUnit(const std::string &time_unit,
double time_unit_scale,
double time_scale) = 0;
virtual void setTimeMax(VcdTime time_max) = 0;
virtual void varMinDeltaTime(VcdTime min_delta_time) = 0;
virtual bool varIdValid(const string &id) = 0;
virtual bool varIdValid(const std::string &id) = 0;
virtual void makeVar(const VcdScope &scope,
const string &name,
const std::string &name,
VcdVarType type,
size_t width,
const string &id) = 0;
virtual void varAppendValue(const string &id,
const std::string &id) = 0;
virtual void varAppendValue(const std::string &id,
VcdTime time,
char value) = 0;
virtual void varAppendBusValue(const string &id,
virtual void varAppendBusValue(const std::string &id,
VcdTime time,
int64_t bus_value) = 0;
};

View File

@ -37,6 +37,8 @@
namespace sta {
using std::string;
static bool
thrusIntersectPts(ExceptionThruSeq *thrus1,
ExceptionThruSeq *thrus2,

View File

@ -30,6 +30,7 @@
#include "Debug.hh"
#include "Mutex.hh"
#include "Report.hh"
#include "Variables.hh"
#include "PatternMatch.hh"
#include "MinMax.hh"
#include "TimingRole.hh"
@ -233,19 +234,6 @@ void
Sdc::initVariables()
{
analysis_type_ = AnalysisType::ocv;
use_default_arrival_clock_ = false;
crpr_enabled_ = true;
crpr_mode_ = CrprMode::same_pin;
propagate_gated_clock_enable_ = true;
preset_clr_arcs_enabled_ = false;
cond_default_arcs_enabled_ = true;
bidirect_net_paths_enabled_ = false;
bidirect_inst_paths_enabled_ = false;
recovery_removal_checks_enabled_ = true;
gated_clk_checks_enabled_ = true;
clk_thru_tristate_enabled_ = false;
dynamic_loop_breaking_ = false;
propagate_all_clks_ = false;
wireload_mode_ = WireloadMode::unknown;
max_area_ = 0.0;
path_delays_without_to_ = false;
@ -1000,7 +988,7 @@ Sdc::makeClock(const char *name,
else {
// Fresh clock definition.
clk = new Clock(name, clk_index_++, network_);
clk->setIsPropagated(propagate_all_clks_);
clk->setIsPropagated(variables_->propagateAllClocks());
clocks_.push_back(clk);
// Use the copied name in the map.
clock_name_map_[clk->name()] = clk;
@ -1041,7 +1029,8 @@ Sdc::makeGeneratedClock(const char *name,
clk->initGeneratedClk(pins, add_to_pins, src_pin, master_clk,
divide_by, multiply_by, duty_cycle,
invert, combinational,
edges, edge_shifts, propagate_all_clks_,
edges, edge_shifts,
variables_->propagateAllClocks(),
comment, network_);
makeClkPinMappings(clk);
clearCycleAcctings();
@ -1249,6 +1238,12 @@ Sdc::sortedClocks(ClockSeq &clks)
sort(clks, ClkNameLess());
}
ClockEdge *
Sdc::defaultArrivalClockEdge() const
{
return default_arrival_clk_->edge(RiseFall::rise());
}
////////////////////////////////////////////////////////////////
class ClkHpinDisable
@ -5481,203 +5476,6 @@ Sdc::setWireloadSelection(WireloadSelection *selection,
////////////////////////////////////////////////////////////////
bool
Sdc::crprEnabled() const
{
return crpr_enabled_;
}
void
Sdc::setCrprEnabled(bool enabled)
{
crpr_enabled_ = enabled;
}
CrprMode
Sdc::crprMode() const
{
return crpr_mode_;
}
void
Sdc::setCrprMode(CrprMode mode)
{
crpr_mode_ = mode;
}
bool
Sdc::crprActive() const
{
return analysis_type_ == AnalysisType::ocv
&& crpr_enabled_;
}
bool
Sdc::propagateGatedClockEnable() const
{
return propagate_gated_clock_enable_;
}
void
Sdc::setPropagateGatedClockEnable(bool enable)
{
propagate_gated_clock_enable_ = enable;
}
bool
Sdc::presetClrArcsEnabled() const
{
return preset_clr_arcs_enabled_;
}
void
Sdc::setPresetClrArcsEnabled(bool enable)
{
preset_clr_arcs_enabled_ = enable;
}
bool
Sdc::condDefaultArcsEnabled() const
{
return cond_default_arcs_enabled_;
}
void
Sdc::setCondDefaultArcsEnabled(bool enabled)
{
cond_default_arcs_enabled_ = enabled;
}
bool
Sdc::isDisabledCondDefault(Edge *edge) const
{
return !cond_default_arcs_enabled_
&& edge->timingArcSet()->isCondDefault();
}
bool
Sdc::bidirectInstPathsEnabled() const
{
return bidirect_inst_paths_enabled_;
}
void
Sdc::setBidirectInstPathsEnabled(bool enabled)
{
bidirect_inst_paths_enabled_ = enabled;
}
// Delay calculation propagates slews from a bidirect driver
// to the bidirect port and back through the bidirect driver when
// sta_bidirect_inst_paths_enabled_ is true.
bool
Sdc::bidirectDrvrSlewFromLoad(const Pin *pin) const
{
return bidirect_inst_paths_enabled_
&& network_->direction(pin)->isBidirect()
&& network_->isTopLevelPort(pin);
}
bool
Sdc::bidirectNetPathsEnabled() const
{
return bidirect_inst_paths_enabled_;
}
void
Sdc::setBidirectNetPathsEnabled(bool enabled)
{
bidirect_inst_paths_enabled_ = enabled;
}
bool
Sdc::recoveryRemovalChecksEnabled() const
{
return recovery_removal_checks_enabled_;
}
void
Sdc::setRecoveryRemovalChecksEnabled(bool enabled)
{
recovery_removal_checks_enabled_ = enabled;
}
bool
Sdc::gatedClkChecksEnabled() const
{
return gated_clk_checks_enabled_;
}
void
Sdc::setGatedClkChecksEnabled(bool enabled)
{
gated_clk_checks_enabled_ = enabled;
}
bool
Sdc::dynamicLoopBreaking() const
{
return dynamic_loop_breaking_;
}
void
Sdc::setDynamicLoopBreaking(bool enable)
{
if (dynamic_loop_breaking_ != enable) {
if (levelize_->levelized()) {
if (enable)
makeLoopExceptions();
else
deleteLoopExceptions();
}
dynamic_loop_breaking_ = enable;
}
}
bool
Sdc::propagateAllClocks() const
{
return propagate_all_clks_;
}
void
Sdc::setPropagateAllClocks(bool prop)
{
propagate_all_clks_ = prop;
}
bool
Sdc::clkThruTristateEnabled() const
{
return clk_thru_tristate_enabled_;
}
void
Sdc::setClkThruTristateEnabled(bool enable)
{
clk_thru_tristate_enabled_ = enable;
}
ClockEdge *
Sdc::defaultArrivalClockEdge() const
{
return default_arrival_clk_->edge(RiseFall::rise());
}
bool
Sdc::useDefaultArrivalClock()
{
return use_default_arrival_clock_;
}
void
Sdc::setUseDefaultArrivalClock(bool enable)
{
use_default_arrival_clock_ = enable;
}
////////////////////////////////////////////////////////////////
void
Sdc::connectPinAfter(const Pin *pin)
{

131
sdc/Variables.cc Normal file
View File

@ -0,0 +1,131 @@
// OpenSTA, Static Timing Analyzer
// Copyright (c) 2025, Parallax Software, Inc.
//
// 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 3 of the License, or
// (at your option) any later version.
//
// This program 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 General Public License for more details.
//
// You should have received a copy of the GNU General Public License
// along with this program. If not, see <https://www.gnu.org/licenses/>.
//
// The origin of this software must not be misrepresented; you must not
// claim that you wrote the original software.
//
// Altered source versions must be plainly marked as such, and must not be
// misrepresented as being the original software.
//
// This notice may not be removed or altered from any source distribution.
#include "Variables.hh"
namespace sta {
Variables::Variables() :
crpr_enabled_(true),
crpr_mode_(CrprMode::same_pin),
propagate_gated_clock_enable_(true),
preset_clr_arcs_enabled_(false),
cond_default_arcs_enabled_(true),
bidirect_net_paths_enabled_(false),
bidirect_inst_paths_enabled_(false),
recovery_removal_checks_enabled_(true),
gated_clk_checks_enabled_(true),
clk_thru_tristate_enabled_(false),
dynamic_loop_breaking_(false),
propagate_all_clks_(false),
use_default_arrival_clock_(false),
pocv_enabled_(false)
{
}
void
Variables::setCrprEnabled(bool enabled)
{
crpr_enabled_ = enabled;
}
void
Variables::setCrprMode(CrprMode mode)
{
crpr_mode_ = mode;
}
void
Variables::setPropagateGatedClockEnable(bool enable)
{
propagate_gated_clock_enable_ = enable;
}
void
Variables::setPresetClrArcsEnabled(bool enable)
{
preset_clr_arcs_enabled_ = enable;
}
void
Variables::setCondDefaultArcsEnabled(bool enabled)
{
cond_default_arcs_enabled_ = enabled;
}
void
Variables::setBidirectInstPathsEnabled(bool enabled)
{
bidirect_inst_paths_enabled_ = enabled;
}
void
Variables::setBidirectNetPathsEnabled(bool enabled)
{
bidirect_net_paths_enabled_ = enabled;
}
void
Variables::setRecoveryRemovalChecksEnabled(bool enabled)
{
recovery_removal_checks_enabled_ = enabled;
}
void
Variables::setGatedClkChecksEnabled(bool enabled)
{
gated_clk_checks_enabled_ = enabled;
}
void
Variables::setDynamicLoopBreaking(bool enable)
{
dynamic_loop_breaking_ = enable;
}
void
Variables::setPropagateAllClocks(bool prop)
{
propagate_all_clks_ = prop;
}
void
Variables::setClkThruTristateEnabled(bool enable)
{
clk_thru_tristate_enabled_ = enable;
}
void
Variables::setUseDefaultArrivalClock(bool enable)
{
use_default_arrival_clock_ = enable;
}
void
Variables::setPocvEnabled(bool enabled)
{
pocv_enabled_ = enabled;
}
} // namespace

View File

@ -55,10 +55,13 @@
#include "Fuzzy.hh"
#include "StaState.hh"
#include "Corner.hh"
#include "Variables.hh"
#include "WriteSdcPvt.hh"
namespace sta {
using std::string;
typedef Set<ClockSense*> ClockSenseSet;
typedef Vector<ClockSense*> ClockSenseSeq;
@ -2324,13 +2327,13 @@ WriteSdc::writeFanoutLimits(const MinMax *min_max,
void
WriteSdc::writeVariables() const
{
if (sdc_->propagateAllClocks()) {
if (variables_->propagateAllClocks()) {
if (native_)
gzprintf(stream_, "set sta_propagate_all_clocks 1\n");
else
gzprintf(stream_, "set timing_all_clocks_propagated true\n");
}
if (sdc_->presetClrArcsEnabled()) {
if (variables_->presetClrArcsEnabled()) {
if (native_)
gzprintf(stream_, "set sta_preset_clear_arcs_enabled 1\n");
else

View File

@ -290,7 +290,7 @@ ReportAnnotated::reportCheckCount(const TimingRole *role,
{
int index = role->index();
if (edge_count_[index] > 0) {
string title;
std::string title;
stringPrint(title, "cell %s arcs", role->to_string().c_str());
reportCount(title.c_str(), index, total, annotated_total);
}

View File

@ -82,7 +82,7 @@ EOL \r?\n
"\"" {
BEGIN INITIAL;
yylval->string = new string(token_);
yylval->string = new std::string(token_);
return token::QSTRING;
}
@ -157,7 +157,7 @@ COND {
<COND_EXPR>"("{BLANK}*IOPATH {
BEGIN INITIAL;
yylval->string = new string(token_);
yylval->string = new std::string(token_);
return token::EXPR_OPEN_IOPATH;
}
@ -167,7 +167,7 @@ COND {
*/
if (reader_->inTimingCheck()) {
BEGIN INITIAL;
yylval->string = new string(token_);
yylval->string = new std::string(token_);
return token::EXPR_OPEN;
}
else
@ -179,9 +179,9 @@ COND {
if (reader_->inTimingCheck()) {
BEGIN INITIAL;
/* remove trailing ")" */
string cond_id(token_);
std::string cond_id(token_);
cond_id += yytext;
yylval->string = new string(cond_id.substr(0, cond_id.size() - 1));
yylval->string = new std::string(cond_id.substr(0, cond_id.size() - 1));
/* No way to pass expr and id separately, so pass them together. */
return token::EXPR_ID_CLOSE;
}
@ -194,7 +194,7 @@ COND {
<COND_EXPR>. { token_ += yytext[0]; }
{ID} {
yylval->string = new string(yytext);
yylval->string = new std::string(yytext);
return token::ID;
}

View File

@ -36,7 +36,7 @@
void
sta::SdfParse::error(const location_type &loc,
const string &msg)
const std::string &msg)
{
reader->report()->fileError(164,reader->filename().c_str(),
loc.begin.line,"%s",msg.c_str());

View File

@ -45,6 +45,7 @@
namespace sta {
using std::string;
using std::to_string;
class SdfTriple
@ -65,8 +66,8 @@ class SdfPortSpec
{
public:
SdfPortSpec(const Transition *tr,
const string *port,
const string *cond);
const std::string *port,
const std::string *cond);
~SdfPortSpec();
const string *port() const { return port_; }
const Transition *transition() const { return tr_; }

View File

@ -59,7 +59,7 @@ public:
void setDivider(char divider);
void setTimescale(float multiplier,
const string *units);
const std::string *units);
void setPortDeviceDelay(Edge *edge,
SdfTripleSeq *triples,
bool from_trans);
@ -80,17 +80,17 @@ public:
int triple_index,
int arc_delay_index,
const MinMax *min_max);
void setInstance(const string *instance_name);
void setInstance(const std::string *instance_name);
void setInstanceWildcard();
void cellFinish();
void setCell(const string *cell_name);
void interconnect(const string *from_pin_name,
const string *to_pin_name,
void setCell(const std::string *cell_name);
void interconnect(const std::string *from_pin_name,
const std::string *to_pin_name,
SdfTripleSeq *triples);
void iopath(SdfPortSpec *from_edge,
const string *to_port_name,
const std::string *to_port_name,
SdfTripleSeq *triples,
const string *cond,
const std::string *cond,
bool condelse);
void timingCheck(const TimingRole *role,
SdfPortSpec *data_edge,
@ -118,10 +118,10 @@ public:
SdfPortSpec *clk_edge,
SdfTriple *before_triple,
SdfTriple *after_triple);
void port(const string *to_pin_name,
void port(const std::string *to_pin_name,
SdfTripleSeq *triples);
void device(SdfTripleSeq *triples);
void device(const string *to_pin_name,
void device(const std::string *to_pin_name,
SdfTripleSeq *triples);
SdfTriple *makeTriple();
@ -133,20 +133,20 @@ public:
SdfTripleSeq *makeTripleSeq();
void deleteTripleSeq(SdfTripleSeq *triples);
SdfPortSpec *makePortSpec(const Transition *tr,
const string *port,
const string *cond);
SdfPortSpec *makeCondPortSpec(const string *cond_port);
string *unescaped(const string *token);
string *makePath(const string *head,
const string *tail);
const std::string *port,
const std::string *cond);
SdfPortSpec *makeCondPortSpec(const std::string *cond_port);
std::string *unescaped(const std::string *token);
std::string *makePath(const std::string *head,
const std::string *tail);
// Parser state used to control lexer for COND handling.
bool inTimingCheck() { return in_timing_check_; }
void setInTimingCheck(bool in);
bool inIncremental() const { return in_incremental_; }
void setInIncremental(bool incr);
string *makeBusName(string *bus_name,
int index);
const string &filename() const { return filename_; }
std::string *makeBusName(std::string *bus_name,
int index);
const std::string &filename() const { return filename_; }
void sdfWarn(int id,
const char *fmt, ...);
void sdfError(int id,
@ -161,11 +161,11 @@ private:
Edge *findCheckEdge(Pin *from_pin,
Pin *to_pin,
const TimingRole *sdf_role,
const string *cond_start,
const string *cond_end);
const std::string *cond_start,
const std::string *cond_end);
Edge *findWireEdge(Pin *from_pin,
Pin *to_pin);
bool condMatch(const string *sdf_cond,
bool condMatch(const std::string *sdf_cond,
const char *lib_cond);
void timingCheck1(const TimingRole *role,
Port *data_port,
@ -180,17 +180,17 @@ private:
const TimingRole *sdf_role,
SdfTriple *triple,
bool match_generic);
Pin *findPin(const string *name);
Instance *findInstance(const string *name);
Pin *findPin(const std::string *name);
Instance *findInstance(const std::string *name);
void setEdgeDelays(Edge *edge,
SdfTripleSeq *triples,
const char *sdf_cmd);
void setDevicePinDelays(Pin *to_pin,
SdfTripleSeq *triples);
Port *findPort(const Cell *cell,
const string *port_name);
const std::string *port_name);
string filename_;
std::string filename_;
SdfScanner *scanner_;
const char *path_;
// Which values to pull out of the sdf triples.
@ -207,7 +207,7 @@ private:
char divider_;
char escape_;
Instance *instance_;
const string *cell_name_;
const std::string *cell_name_;
bool in_timing_check_;
bool in_incremental_;
float timescale_;

View File

@ -41,7 +41,7 @@ class SdfScanner : public SdfFlexLexer
{
public:
SdfScanner(std::istream *stream,
const string &filename,
const std::string &filename,
SdfReader *reader,
Report *report);
virtual ~SdfScanner() {}
@ -57,10 +57,10 @@ public:
using FlexLexer::yylex;
private:
string filename_;
std::string filename_;
SdfReader *reader_;
Report *report_;
string token_;
std::string token_;
};
} // namespace

View File

@ -72,7 +72,7 @@ protected:
ClockSet &clks);
void errorMsgSubst(const char *msg,
int count,
string &error_msg);
std::string &error_msg);
CheckErrorSeq errors_;
};

View File

@ -133,7 +133,7 @@ ClkInfo::asString(const StaState *sta) const
{
Network *network = sta->network();
Corners *corners = sta->corners();
string result;
std::string result;
PathAnalysisPt *path_ap = corners->findPathAnalysisPt(path_ap_index_);
result += path_ap->pathMinMax()->to_string();
@ -217,7 +217,7 @@ clkInfoEqual(const ClkInfo *clk_info1,
const ClkInfo *clk_info2,
const StaState *sta)
{
bool crpr_on = sta->sdc()->crprActive();
bool crpr_on = sta->crprActive();
ClockUncertainties *uncertainties1 = clk_info1->uncertainties();
ClockUncertainties *uncertainties2 = clk_info2->uncertainties();
return clk_info1->clkEdge() == clk_info2->clkEdge()
@ -290,7 +290,7 @@ clkInfoCmp(const ClkInfo *clk_info1,
if (gen_clk_src1 > gen_clk_src2)
return 1;
bool crpr_on = sta->sdc()->crprActive();
bool crpr_on = sta->crprActive();
if (crpr_on) {
const Path *crpr_path1 = clk_info1->crprClkPath(sta);
const Path *crpr_path2 = clk_info2->crprClkPath(sta);

View File

@ -149,7 +149,7 @@ Corners::makeParasiticAnalysisPts(bool per_corner)
int ap_index = corner->index() * MinMax::index_count + mm_index;
int ap_index_max = corner->index() * MinMax::index_count
+ MinMax::max()->index();
string ap_name = corner->name();
std::string ap_name = corner->name();
ap_name += "_";
ap_name += min_max->to_string();
ParasiticAnalysisPt *ap = new ParasiticAnalysisPt(ap_name.c_str(),

View File

@ -41,6 +41,7 @@
#include "PathEnd.hh"
#include "Search.hh"
#include "Genclks.hh"
#include "Variables.hh"
namespace sta {
@ -107,9 +108,9 @@ CheckCrpr::checkCrpr(const Path *src_path,
{
crpr = 0.0;
crpr_pin = nullptr;
if (sdc_->crprActive()
if (crprActive()
&& src_path && tgt_clk_path) {
bool same_pin = (sdc_->crprMode() == CrprMode::same_pin);
bool same_pin = (variables_->crprMode() == CrprMode::same_pin);
checkCrpr1(src_path, tgt_clk_path, same_pin, crpr, crpr_pin);
}
}
@ -267,7 +268,7 @@ Crpr
CheckCrpr::findCrpr1(const Path *src_clk_path,
const Path *tgt_clk_path)
{
if (pocv_enabled_) {
if (variables_->pocvEnabled()) {
// Remove variation on the common path.
// Note that the crpr sigma is negative to offset the
// sigma of the common clock path.
@ -329,10 +330,10 @@ CheckCrpr::outputDelayCrpr(const Path *src_path,
{
crpr = 0.0;
crpr_pin = nullptr;
if (sdc_->crprActive()) {
if (crprActive()) {
const PathAnalysisPt *path_ap = src_path->pathAnalysisPt(this);
const PathAnalysisPt *tgt_path_ap = path_ap->tgtClkAnalysisPt();
bool same_pin = (sdc_->crprMode() == CrprMode::same_pin);
bool same_pin = (variables_->crprMode() == CrprMode::same_pin);
outputDelayCrpr1(src_path,tgt_clk_edge,tgt_path_ap, same_pin,
crpr, crpr_pin);
}

View File

@ -42,6 +42,7 @@
#include "Levelize.hh"
#include "Path.hh"
#include "Search.hh"
#include "Variables.hh"
namespace sta {
@ -249,7 +250,7 @@ GenClkMasterSearchPred::searchFrom(const Vertex *from_vertex)
bool
GenClkMasterSearchPred::searchThru(Edge *edge)
{
const Sdc *sdc = sta_->sdc();
const Variables *variables = sta_->variables();
const TimingRole *role = edge->role();
// Propagate clocks through constants.
return !(edge->role()->isTimingCheck()
@ -257,14 +258,14 @@ GenClkMasterSearchPred::searchThru(Edge *edge)
|| edge->isDisabledConstraint()
// Constants disable edge cond expression.
|| edge->isDisabledCond()
|| sdc->isDisabledCondDefault(edge)
|| sta_->isDisabledCondDefault(edge)
// Register/latch preset/clr edges are disabled by default.
|| (!sdc->presetClrArcsEnabled()
|| (!variables->presetClrArcsEnabled()
&& role == TimingRole::regSetClr())
|| (edge->isBidirectInstPath()
&& !sdc->bidirectInstPathsEnabled())
&& !variables->bidirectInstPathsEnabled())
|| (edge->isBidirectNetPath()
&& !sdc->bidirectNetPathsEnabled()));
&& !variables->bidirectNetPathsEnabled()));
}
bool
@ -481,7 +482,7 @@ GenClkInsertionSearchPred::searchThru(Edge *edge)
EdgeSet *fdbk_edges = genclk_info_->fdbkEdges();
return SearchPred0::searchThru(edge)
&& !role->isTimingCheck()
&& (sdc->clkThruTristateEnabled()
&& (sta_->variables()->clkThruTristateEnabled()
|| !(role == TimingRole::tristateEnable()
|| role == TimingRole::tristateDisable()))
&& !(fdbk_edges && fdbk_edges->hasKey(edge))
@ -740,13 +741,12 @@ GenClkArrivalSearchPred::GenClkArrivalSearchPred(Clock *gclk,
bool
GenClkArrivalSearchPred::searchThru(Edge *edge)
{
const Sdc *sdc = sta_->sdc();
const TimingRole *role = edge->role();
return EvalPred::searchThru(edge)
&& (role == TimingRole::combinational()
|| role->isWire()
|| !combinational_)
&& (sdc->clkThruTristateEnabled()
&& (sta_->variables()->clkThruTristateEnabled()
|| !(role == TimingRole::tristateEnable()
|| role == TimingRole::tristateDisable()));
}
@ -895,7 +895,7 @@ Genclks::recordSrcPaths(Clock *gclk)
bool has_edges = gclk->edges() != nullptr;
for (const Pin *gclk_pin : gclk->leafPins()) {
vector<Path> &src_paths = genclk_src_paths_[ClockPinPair(gclk, gclk_pin)];
std::vector<Path> &src_paths = genclk_src_paths_[ClockPinPair(gclk, gclk_pin)];
src_paths.resize(path_count);
Vertex *gclk_vertex = srcPath(gclk_pin);
bool found_src_paths = false;
@ -1002,7 +1002,7 @@ Genclks::srcPath(const Clock *gclk,
{
auto itr = genclk_src_paths_.find(ClockPinPair(gclk, src_pin));
if (itr != genclk_src_paths_.end()) {
vector<Path> src_paths = itr->second;
std::vector<Path> src_paths = itr->second;
if (!src_paths.empty()) {
size_t path_index = srcPathIndex(rf, path_ap);
Path &src_path = src_paths[path_index];
@ -1023,12 +1023,10 @@ Genclks::updateSrcPathPrevs()
if (!src_path.isNull()) {
const Path *p = &src_path;
while (p) {
Path *src_vpath = Path::vertexPath(p->vertex(this),
p->tag(this), this);
Path *src_vpath = Path::vertexPath(p, this);
Path *prev_path = p->prevPath();
if (prev_path) {
Path *prev_vpath = Path::vertexPath(prev_path->vertex(this),
prev_path->tag(this), this);
Path *prev_vpath = Path::vertexPath(prev_path, this);
src_vpath->setPrevPath(prev_vpath);
src_vpath->setPrevEdgeArc(p->prevEdge(this),
p->prevArc(this), this);

View File

@ -50,7 +50,7 @@ public:
};
typedef Map<Clock*, GenclkInfo*> GenclkInfoMap;
typedef Map<ClockPinPair, vector<Path>, ClockPinPairLess> GenclkSrcPathMap;
typedef Map<ClockPinPair, std::vector<Path>, ClockPinPairLess> GenclkSrcPathMap;
class Genclks : public StaState
{

View File

@ -352,8 +352,7 @@ Latches::latchOutArrival(const Path *data_path,
q_arrival = adjusted_data_arrival + arc_delay;
// Tag switcheroo - data passing thru gets latch enable tag.
// States and path ap come from Q, everything else from enable.
Path *crpr_clk_path =
sdc_->crprActive() ? enable_path : nullptr;
Path *crpr_clk_path = crprActive() ? enable_path : nullptr;
ClkInfo *q_clk_info =
search_->findClkInfo(en_clk_edge,
en_clk_info->clkSrc(),

View File

@ -36,6 +36,8 @@
#include "Graph.hh"
#include "GraphCmp.hh"
#include "SearchPred.hh"
#include "Variables.hh"
#include "GraphDelayCalc.hh"
namespace sta {
@ -185,7 +187,7 @@ Levelize::isRoot(Vertex *vertex)
return false;
}
// Bidirect pins are not treated as roots in this case.
return !sdc_->bidirectDrvrSlewFromLoad(vertex->pin());
return !graph_delay_calc_->bidirectDrvrSlewFromLoad(vertex->pin());
}
else
return false;
@ -250,7 +252,7 @@ Levelize::visit(Vertex *vertex,
latch_d_to_q_edges_.insert(edge);
}
// Levelize bidirect driver as if it was a fanout of the bidirect load.
if (sdc_->bidirectDrvrSlewFromLoad(from_pin)
if (graph_delay_calc_->bidirectDrvrSlewFromLoad(from_pin)
&& !vertex->isBidirectDriver()) {
Vertex *to_vertex = graph_->pinDrvrVertex(from_pin);
if (search_pred_->searchTo(to_vertex)
@ -288,7 +290,7 @@ Levelize::recordLoop(Edge *edge,
EdgeSeq *loop_edges = loopEdges(path, edge);
GraphLoop *loop = new GraphLoop(loop_edges);
loops_->push_back(loop);
if (sdc_->dynamicLoopBreaking())
if (variables_->dynamicLoopBreaking())
sdc_->makeLoopExceptions(loop);
}
// Record disabled loop edges so they can be cleared without

View File

@ -209,6 +209,7 @@ MakeTimingModel::makePorts()
float load_cap = graph_delay_calc_->loadCap(pin, dcalc_ap);
lib_bit_port->setCapacitance(load_cap);
}
delete member_iter;
}
else {
LibertyPort *lib_port = lib_builder_->makePort(cell_, port_name);

Some files were not shown because too many files have changed in this diff Show More