Skip to content

Commit

Permalink
Update char * to char*
Browse files Browse the repository at this point in the history
  • Loading branch information
andrjohns committed Sep 19, 2023
1 parent 5be6653 commit 57cc140
Show file tree
Hide file tree
Showing 12 changed files with 16 additions and 16 deletions.
2 changes: 1 addition & 1 deletion stan/math/opencl/kernels/add.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -12,7 +12,7 @@ namespace math {
namespace opencl_kernels {

// \cond
static constexpr const char *add_batch_kernel_code = STRINGIFY(
static constexpr const char* add_batch_kernel_code = STRINGIFY(
// \endcond
/** \ingroup opencl_kernels
* Sums a batch of matrices. Buffer A contains
Expand Down
2 changes: 1 addition & 1 deletion stan/math/opencl/kernels/check_symmetric.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -10,7 +10,7 @@ namespace stan {
namespace math {
namespace opencl_kernels {
// \cond
static constexpr const char *is_symmetric_kernel_code = STRINGIFY(
static constexpr const char* is_symmetric_kernel_code = STRINGIFY(
// \endcond
/** \ingroup opencl_kernels
* Check if the <code>matrix_cl</code> is symmetric
Expand Down
6 changes: 3 additions & 3 deletions stan/math/opencl/kernels/cumulative_sum.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -12,7 +12,7 @@ namespace math {
namespace opencl_kernels {

// \cond
static constexpr const char *cumulative_sum1_kernel_code = STRINGIFY(
static constexpr const char* cumulative_sum1_kernel_code = STRINGIFY(
// \endcond
/** \ingroup opencl_kernels
* First kernel of the cumulative sum implementation. Each thread sums the
Expand Down Expand Up @@ -62,7 +62,7 @@ static constexpr const char *cumulative_sum1_kernel_code = STRINGIFY(
// \endcond

// \cond
static constexpr const char *cumulative_sum2_kernel_code = STRINGIFY(
static constexpr const char* cumulative_sum2_kernel_code = STRINGIFY(
// \endcond
/** \ingroup opencl_kernels
* Second kernel of the cumulative sum implementation. Calculates prefix sum
Expand Down Expand Up @@ -116,7 +116,7 @@ static constexpr const char *cumulative_sum2_kernel_code = STRINGIFY(
// \endcond

// \cond
static constexpr const char *cumulative_sum3_kernel_code = STRINGIFY(
static constexpr const char* cumulative_sum3_kernel_code = STRINGIFY(
// \endcond
/** \ingroup opencl_kernels
* Third kernel of the cumulative sum implementation. Given sums of threads
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -9,7 +9,7 @@ namespace stan {
namespace math {
namespace opencl_kernels {
// \cond
static constexpr const char *atomic_add_double_device_function
static constexpr const char* atomic_add_double_device_function
= "\n"
"#ifndef STAN_MATH_OPENCL_KERNELS_DEVICE_FUNCTIONS_ATOMIC_ADD_DOUBLE\n"
"#define STAN_MATH_OPENCL_KERNELS_DEVICE_FUNCTIONS_ATOMIC_ADD_DOUBLE\n"
Expand Down
2 changes: 1 addition & 1 deletion stan/math/opencl/kernels/divide_columns.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -10,7 +10,7 @@ namespace stan {
namespace math {
namespace opencl_kernels {
// \cond
static constexpr const char *divide_columns_kernel_code = STRINGIFY(
static constexpr const char* divide_columns_kernel_code = STRINGIFY(
// \endcond
/** \ingroup opencl_kernels
* Takes vector A and divides columns vector in A element-wise by the values
Expand Down
2 changes: 1 addition & 1 deletion stan/math/prim/prob/beta_binomial_rng.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -35,7 +35,7 @@ beta_binomial_rng(const T_N &N, const T_shape1 &alpha, const T_shape2 &beta,
using T_N_ref = ref_type_t<T_N>;
using T_alpha_ref = ref_type_t<T_shape1>;
using T_beta_ref = ref_type_t<T_shape2>;
static constexpr const char *function = "beta_binomial_rng";
static constexpr const char* function = "beta_binomial_rng";
check_consistent_sizes(function, "First prior sample size parameter", alpha,
"Second prior sample size parameter", beta);

Expand Down
2 changes: 1 addition & 1 deletion stan/math/prim/prob/beta_proportion_rng.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -36,7 +36,7 @@ inline typename VectorBuilder<true, double, T_loc, T_prec>::type
beta_proportion_rng(const T_loc &mu, const T_prec &kappa, RNG &rng) {
using T_mu_ref = ref_type_t<T_loc>;
using T_kappa_ref = ref_type_t<T_prec>;
static constexpr const char *function = "beta_proportion_rng";
static constexpr const char* function = "beta_proportion_rng";
check_consistent_sizes(function, "Location parameter", mu,
"Precision parameter", kappa);
T_mu_ref mu_ref = mu;
Expand Down
2 changes: 1 addition & 1 deletion stan/math/prim/prob/beta_rng.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -40,7 +40,7 @@ inline typename VectorBuilder<true, double, T_shape1, T_shape2>::type beta_rng(
using boost::random::uniform_real_distribution;
using T_alpha_ref = ref_type_t<T_shape1>;
using T_beta_ref = ref_type_t<T_shape2>;
static constexpr const char *function = "beta_rng";
static constexpr const char* function = "beta_rng";
check_consistent_sizes(function, "First shape parameter", alpha,
"Second shape Parameter", beta);
T_alpha_ref alpha_ref = alpha;
Expand Down
2 changes: 1 addition & 1 deletion stan/math/prim/prob/gaussian_dlm_obs_rng.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -92,7 +92,7 @@ inline Eigen::MatrixXd gaussian_dlm_obs_rng(const Eigen::MatrixXd &F,
const Eigen::VectorXd &m0,
const Eigen::MatrixXd &C0,
const int T, RNG &rng) {
static constexpr const char *function = "gaussian_dlm_obs_rng";
static constexpr const char* function = "gaussian_dlm_obs_rng";

int r = F.cols(); // number of variables
int n = G.rows(); // number of states
Expand Down
2 changes: 1 addition & 1 deletion stan/math/prim/prob/matrix_normal_prec_rng.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -35,7 +35,7 @@ inline Eigen::MatrixXd matrix_normal_prec_rng(const Eigen::MatrixXd &Mu,
RNG &rng) {
using boost::normal_distribution;
using boost::variate_generator;
static constexpr const char *function = "matrix_normal_prec_rng";
static constexpr const char* function = "matrix_normal_prec_rng";
check_positive(function, "Sigma rows", Sigma.rows());
check_finite(function, "Sigma", Sigma);
check_symmetric(function, "Sigma", Sigma);
Expand Down
2 changes: 1 addition & 1 deletion stan/math/prim/prob/multi_normal_prec_rng.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -34,7 +34,7 @@ inline typename StdVectorBuilder<true, Eigen::VectorXd, T_loc>::type
multi_normal_prec_rng(const T_loc &mu, const Eigen::MatrixXd &S, RNG &rng) {
using boost::normal_distribution;
using boost::variate_generator;
static constexpr const char *function = "multi_normal_prec_rng";
static constexpr const char* function = "multi_normal_prec_rng";
check_positive(function, "Precision matrix rows", S.rows());

vector_seq_view<T_loc> mu_vec(mu);
Expand Down
6 changes: 3 additions & 3 deletions stan/math/rev/fun/mdivide_left_spd.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -154,7 +154,7 @@ mdivide_left_spd(const EigMat1 &A, const EigMat2 &b) {
constexpr int C1 = EigMat1::ColsAtCompileTime;
constexpr int R2 = EigMat2::RowsAtCompileTime;
constexpr int C2 = EigMat2::ColsAtCompileTime;
static constexpr const char *function = "mdivide_left_spd";
static constexpr const char* function = "mdivide_left_spd";
check_multiplicable(function, "A", A, "b", b);
const auto &A_ref = to_ref(A);
check_symmetric(function, "A", A_ref);
Expand Down Expand Up @@ -185,7 +185,7 @@ mdivide_left_spd(const EigMat1 &A, const EigMat2 &b) {
constexpr int C1 = EigMat1::ColsAtCompileTime;
constexpr int R2 = EigMat2::RowsAtCompileTime;
constexpr int C2 = EigMat2::ColsAtCompileTime;
static constexpr const char *function = "mdivide_left_spd";
static constexpr const char* function = "mdivide_left_spd";
check_multiplicable(function, "A", A, "b", b);
const auto &A_ref = to_ref(A);
check_symmetric(function, "A", A_ref);
Expand Down Expand Up @@ -216,7 +216,7 @@ mdivide_left_spd(const EigMat1 &A, const EigMat2 &b) {
constexpr int C1 = EigMat1::ColsAtCompileTime;
constexpr int R2 = EigMat2::RowsAtCompileTime;
constexpr int C2 = EigMat2::ColsAtCompileTime;
static constexpr const char *function = "mdivide_left_spd";
static constexpr const char* function = "mdivide_left_spd";
check_multiplicable(function, "A", A, "b", b);
const auto &A_ref = to_ref(A);
check_symmetric(function, "A", A_ref);
Expand Down

0 comments on commit 57cc140

Please sign in to comment.