本文整理汇总了C++中ADB类的典型用法代码示例。如果您正苦于以下问题:C++ ADB类的具体用法?C++ ADB怎么用?C++ ADB使用的例子?那么, 这里精选的类代码示例或许可以为您提供帮助。
在下文中一共展示了ADB类的15个代码示例,这些例子默认根据受欢迎程度排序。您可以为喜欢或者感觉有用的代码点赞,您的评价将有助于系统推荐出更棒的C++代码示例。
示例1: strcpy
void LogCall::setLoginID(const char * newLoginID)
{
QApplication::setOverrideCursor(waitCursor);
if (strlen(newLoginID) < 32) {
strcpy(myLoginID, newLoginID);
loginID->setText(myLoginID);
if (strlen(myLoginID)) {
// Now, get the customer ID for this login ID
char *query = new char[32768];
ADB DB;
DB.query("select CustomerID from Logins where LoginID = '%s'", myLoginID);
if (DB.rowCount == 1) {
DB.getrow();
myCustID = atol(DB.curRow["CustomerID"]);
// Load the customer's name so we can verify who we're talking
// to.
CustomersDB CDB;
CDB.get(myCustID);
strcpy(custName, (const char *) CDB.getStr("FullName"));
sprintf(query, "Customer ID %ld selected (%s)", myCustID, custName);
statusLabel->setText(query);
} else {
myCustID = 0;
statusLabel->setText("No customer selected");
}
} else {
myCustID = 0;
statusLabel->setText("No customer selected");
}
}
QApplication::restoreOverrideCursor();
}
示例2: fillDepositList
void MakeDeposits::fillDepositList()
{
QApplication::setOverrideCursor(waitCursor);
ADB DB;
char tmpStr[1024];
float totalFunds = 0.00;
strcpy(tmpStr, cfgVal("UndepositedFundsAccount"));
emit(setStatus("Creating undeposited funds list..."));
DB.query("select GL.InternalID, GL.TransDate, GL.Amount, AcctsRecv.RefNo, AcctsRecv.CustomerID, Customers.FullName from GL, AcctsRecv, Customers where GL.IntAccountNo = %d and GL.TransType = 2 and AcctsRecv.InternalID = GL.TransTypeLink and AcctsRecv.RefNo > 0 and Customers.CustomerID = AcctsRecv.CustomerID and GL.Cleared = 0", atoi(cfgVal("UndepositedFundsAcct")));
//DB.query("select * from GL where AccountNo = %d and LinkedTrans = 0", atoi(tmpStr));
if (DB.rowCount) while (DB.getrow()) {
(void) new Q3ListViewItem(paymentList,
DB.curRow["TransDate"],
DB.curRow["CustomerID"],
DB.curRow["FullName"],
DB.curRow["RefNo"],
DB.curRow["Amount"],
DB.curRow["InternalID"]
);
totalFunds += atof(DB.curRow["Amount"]);
}
sprintf(tmpStr, "$%.2f", totalFunds);
undepositedAmount->setText(tmpStr);
emit(setStatus(""));
QApplication::restoreOverrideCursor();
}
示例3: vertcat
/// Solve the linear system Ax = b, with A being the
/// combined derivative matrix of the residual and b
/// being the residual itself.
/// \param[in] residual residual object containing A and b.
/// \return the solution x
NewtonIterationBlackoilSimple::SolutionVector
NewtonIterationBlackoilSimple::computeNewtonIncrement(const LinearisedBlackoilResidual& residual) const
{
typedef LinearisedBlackoilResidual::ADB ADB;
const int np = residual.material_balance_eq.size();
ADB mass_res = residual.material_balance_eq[0];
for (int phase = 1; phase < np; ++phase) {
mass_res = vertcat(mass_res, residual.material_balance_eq[phase]);
}
const ADB well_res = vertcat(residual.well_flux_eq, residual.well_eq);
const ADB total_residual = collapseJacs(vertcat(mass_res, well_res));
Eigen::SparseMatrix<double, Eigen::RowMajor> matr;
total_residual.derivative()[0].toSparse(matr);
SolutionVector dx(SolutionVector::Zero(total_residual.size()));
Opm::LinearSolverInterface::LinearSolverReport rep
= linsolver_->solve(matr.rows(), matr.nonZeros(),
matr.outerIndexPtr(), matr.innerIndexPtr(), matr.valuePtr(),
total_residual.value().data(), dx.data(), parallelInformation_);
// store iterations
iterations_ = rep.iterations;
if (!rep.converged) {
OPM_THROW(LinearSolverProblem,
"FullyImplicitBlackoilSolver::solveJacobianSystem(): "
"Linear solver convergence failure.");
}
return dx;
}
示例4: BOOST_FIXTURE_TEST_CASE
BOOST_FIXTURE_TEST_CASE(ViscosityAD, TestFixture<SetupSimple>)
{
const Opm::BlackoilPropsAdFromDeck::Cells cells(5, 0);
typedef Opm::BlackoilPropsAdFromDeck::V V;
typedef Opm::BlackoilPropsAdFromDeck::ADB ADB;
V Vpw;
Vpw.resize(cells.size());
Vpw[0] = 1*Opm::unit::barsa;
Vpw[1] = 2*Opm::unit::barsa;
Vpw[2] = 4*Opm::unit::barsa;
Vpw[3] = 8*Opm::unit::barsa;
Vpw[4] = 16*Opm::unit::barsa;
// standard temperature
V T = V::Constant(cells.size(), 273.15+20);
typedef Opm::BlackoilPropsAdFromDeck::ADB ADB;
const V VmuWat = boprops_ad.muWat(ADB::constant(Vpw), ADB::constant(T), cells).value();
for (V::Index i = 0, n = Vpw.size(); i < n; ++i) {
const std::vector<int> bp(1, grid.c_grid()->number_of_cells);
const Opm::BlackoilPropsAdFromDeck::Cells c(1, 0);
const V pw = V(1, 1) * Vpw[i];
const ADB Apw = ADB::variable(0, pw, bp);
const ADB AT = ADB::constant(T);
const ADB AmuWat = boprops_ad.muWat(Apw, AT, c);
BOOST_CHECK_EQUAL(AmuWat.value()[0], VmuWat[i]);
}
}
示例5: OPM_THROW
/// Gas formation volume factor.
/// \param[in] pg Array of n gas pressure values.
/// \param[in] rv Array of n vapor oil/gas ratio
/// \param[in] cond Array of n objects, each specifying which phases are present with non-zero saturation in a cell.
/// \param[in] cells Array of n cell indices to be associated with the pressure values.
/// \return Array of n formation volume factor values.
ADB BlackoilPropsAd::bGas(const ADB& pg,
const ADB& rv,
const std::vector<PhasePresence>& /*cond*/,
const Cells& cells) const
{
if (!pu_.phase_used[Gas]) {
OPM_THROW(std::runtime_error, "Cannot call muGas(): gas phase not present.");
}
const int n = cells.size();
assert(pg.value().size() == n);
const int np = props_.numPhases();
Block z = Block::Zero(n, np);
if (pu_.phase_used[Oil]) {
// Faking a z with the right ratio:
// rv = zo/zg
z.col(pu_.phase_pos[Oil]) = rv.value();
z.col(pu_.phase_pos[Gas]) = V::Ones(n, 1);
}
Block matrix(n, np*np);
Block dmatrix(n, np*np);
props_.matrix(n, pg.value().data(), z.data(), cells.data(), matrix.data(), dmatrix.data());
const int phase_ind = pu_.phase_pos[Gas];
const int column = phase_ind*np + phase_ind; // Index of our sought diagonal column.
ADB::M db_diag = spdiag(dmatrix.col(column));
const int num_blocks = pg.numBlocks();
std::vector<ADB::M> jacs(num_blocks);
for (int block = 0; block < num_blocks; ++block) {
jacs[block] = db_diag * pg.derivative()[block];
}
return ADB::function(matrix.col(column), jacs);
}
示例6: OPM_THROW
/// Gas formation volume factor.
/// \param[in] pg Array of n gas pressure values.
/// \param[in] cells Array of n cell indices to be associated with the pressure values.
/// \return Array of n formation volume factor values.
ADB BlackoilPropsAdFromDeck::bGas(const ADB& pg,
const Cells& cells) const
{
if (!phase_usage_.phase_used[Gas]) {
OPM_THROW(std::runtime_error, "Cannot call muGas(): gas phase not present.");
}
const int n = cells.size();
assert(pg.size() == n);
V b(n);
V dbdp(n);
V dbdr(n);
const double* rs = 0;
props_[phase_usage_.phase_pos[Gas]]->b(n, pg.value().data(), rs,
b.data(), dbdp.data(), dbdr.data());
ADB::M dbdp_diag = spdiag(dbdp);
const int num_blocks = pg.numBlocks();
std::vector<ADB::M> jacs(num_blocks);
for (int block = 0; block < num_blocks; ++block) {
jacs[block] = dbdp_diag * pg.derivative()[block];
}
return ADB::function(b, jacs);
}
示例7: assert
ADB SolventPropsAdFromDeck::muSolvent(const ADB& pg,
const Cells& cells) const
{
const int n = cells.size();
assert(pg.value().size() == n);
V mu(n);
V dmudp(n);
for (int i = 0; i < n; ++i) {
const double& pg_i = pg.value()[i];
int regionIdx = cellPvtRegionIdx_[cells[i]];
double tempInvB = b_[regionIdx](pg_i);
double tempInvBmu = inverseBmu_[regionIdx](pg_i);
mu[i] = tempInvB / tempInvBmu;
dmudp[i] = (tempInvBmu * b_[regionIdx].derivative(pg_i)
- tempInvB * inverseBmu_[regionIdx].derivative(pg_i)) / (tempInvBmu * tempInvBmu);
}
ADB::M dmudp_diag(dmudp.matrix().asDiagonal());
const int num_blocks = pg.numBlocks();
std::vector<ADB::M> jacs(num_blocks);
for (int block = 0; block < num_blocks; ++block) {
jacs[block] = dmudp_diag * pg.derivative()[block];
}
return ADB::function(std::move(mu), std::move(jacs));
}
示例8: refreshReport
void UnreleasedDomainsReport::refreshReport()
{
repBody->clear();
ADB DB;
DB.query("select Domains.CustomerID, Domains.LoginID, DomainTypes.DomainType, Domains.DomainName from Domains, DomainTypes where Domains.Active <> 0 and Domains.Released = '' and DomainTypes.InternalID = Domains.DomainType");
if (DB.rowCount) while (DB.getrow()) {
(void) new Q3ListViewItem(repBody, DB.curRow["CustomerID"], DB.curRow["LoginID"], DB.curRow["DomainType"], DB.curRow["DomainName"]);
}
}
示例9: refreshList
void UserPrivs::refreshList()
{
ADB DB;
char levelStr[1024];
AccessLevels level;
Q3ListViewItem *curItem;
bool foundSel = false;
userList->clear();
DB.query("select * from Staff");
if (DB.rowCount) {
while(DB.getrow()) {
level = (AccessLevels) atoi(DB.curRow["AccessLevel"]);
switch(level) {
case Admin:
strcpy(levelStr, "Administrator");
break;
case Manager:
strcpy(levelStr, "Manager");
break;
case Staff:
strcpy(levelStr, "Support Staff");
break;
default:
strcpy(levelStr, "Unknown");
break;
}
curItem = new Q3ListViewItem(userList, DB.curRow["LoginID"], levelStr, DB.curRow["InternalID"]);
// Is this the user we previously had hilighted? If so,
// hilight it now.
if (myCurrentID == atol(DB.curRow["InternalID"])) {
foundSel = true;
userList->setCurrentItem(curItem);
userList->setSelected(curItem, true);
userList->ensureItemVisible(curItem);
}
}
}
// If we didn't find our previously hilighted entry, hilight the
// first entry in the list.
if (!foundSel) {
// None selected, hilight the first one in the list.
if (userList->firstChild()) {
userList->setCurrentItem(userList->firstChild());
userList->setSelected(userList->firstChild(), true);
userList->ensureItemVisible(userList->firstChild());
}
}
}
示例10: setGLAccount
/**
* setGLAccount()
*
* Overrides the GL Account that we post to - not the AcctsRecv side
* but the billable side of the transaction.
*
* Returns 1 if successful, 0 if not.
*/
int AcctsRecv::setGLAccount(int intAcctNo)
{
int retVal = 0;
ADB DB;
DB.query("select IntAccountNo from Accounts where IntAccountNo = '%d'", intAcctNo);
if (DB.rowCount) {
myIntAcctNo = intAcctNo;
retVal = 1;
}
return retVal;
}
示例11: loadCities
void TE_Cities::loadCities()
{
QApplication::setOverrideCursor(Qt::waitCursor);
ADB DB;
DB.query("select distinct City, State from Addresses where RefFrom = %d", REF_CUSTOMER);
if (DB.rowCount) while (DB.getrow()) {
(void) new Q3ListViewItem(cityList, DB.curRow["City"], DB.curRow["State"]);
}
QApplication::restoreOverrideCursor();
}
示例12: THROW
/// Oil viscosity.
/// \param[in] po Array of n oil pressure values.
/// \param[in] rs Array of n gas solution factor values.
/// \param[in] cells Array of n cell indices to be associated with the pressure values.
/// \return Array of n viscosity values.
ADB BlackoilPropsAd::muOil(const ADB& po,
const ADB& rs,
const Cells& cells) const
{
#if 1
return ADB::constant(muOil(po.value(), rs.value(), cells), po.blockPattern());
#else
if (!pu_.phase_used[Oil]) {
THROW("Cannot call muOil(): oil phase not present.");
}
const int n = cells.size();
ASSERT(po.value().size() == n);
const int np = props_.numPhases();
Block z = Block::Zero(n, np);
if (pu_.phase_used[Gas]) {
// Faking a z with the right ratio:
// rs = zg/zo
z.col(pu_.phase_pos[Oil]) = V::Ones(n, 1);
z.col(pu_.phase_pos[Gas]) = rs.value();
}
Block mu(n, np);
Block dmu(n, np);
props_.viscosity(n, po.value().data(), z.data(), cells.data(), mu.data(), dmu.data());
ADB::M dmu_diag = spdiag(dmu.col(pu_.phase_pos[Oil]));
const int num_blocks = po.numBlocks();
std::vector<ADB::M> jacs(num_blocks);
for (int block = 0; block < num_blocks; ++block) {
// For now, we deliberately ignore the derivative with respect to rs,
// since the BlackoilPropertiesInterface class does not evaluate it.
// We would add to the next line: + dmu_drs_diag * rs.derivative()[block]
jacs[block] = dmu_diag * po.derivative()[block];
}
return ADB::function(mu.col(pu_.phase_pos[Oil]), jacs);
#endif
}
示例13: refreshList
void BillingCycles::refreshList(int)
{
ADB DB;
Q3ListViewItem *curItem = NULL;
// Save the state of the list.
list->clear();
DB.query("select CycleID, CycleType, Description from BillingCycles order by CycleID");
if (DB.rowCount) while(DB.getrow()) {
curItem = new Q3ListViewItem(list, DB.curRow["CycleID"], DB.curRow["CycleType"], DB.curRow["Description"]);
}
list->repaint();
}
示例14: miscibleResidualOilSaturationFunction
ADB SolventPropsAdFromDeck::miscibleResidualOilSaturationFunction (const ADB& Sw,
const Cells& cells) const {
if (sorwmis_.size()>0) {
return SolventPropsAdFromDeck::makeADBfromTables(Sw, cells, cellMiscRegionIdx_, sorwmis_);
}
// return zeros if not specified
return ADB::constant(V::Zero(Sw.size()));
}
示例15: infinityNormWell
inline
double infinityNormWell( const ADB& a, const boost::any& pinfo )
{
static_cast<void>(pinfo); // Suppress warning in non-MPI case.
double result=0;
if( a.value().size() > 0 ) {
result = a.value().matrix().template lpNorm<Eigen::Infinity> ();
}
#if HAVE_MPI
if ( pinfo.type() == typeid(ParallelISTLInformation) )
{
const ParallelISTLInformation& real_info =
boost::any_cast<const ParallelISTLInformation&>(pinfo);
result = real_info.communicator().max(result);
}
#endif
return result;
}