[d24f17c] | 1 | /*
|
---|
| 2 | Language: Maxima
|
---|
| 3 | Author: Robert Dodier <robert.dodier@gmail.com>
|
---|
| 4 | Website: http://maxima.sourceforge.net
|
---|
| 5 | Category: scientific
|
---|
| 6 | */
|
---|
| 7 |
|
---|
| 8 | function maxima(hljs) {
|
---|
| 9 | const KEYWORDS =
|
---|
| 10 | 'if then else elseif for thru do while unless step in and or not';
|
---|
| 11 | const LITERALS =
|
---|
| 12 | 'true false unknown inf minf ind und %e %i %pi %phi %gamma';
|
---|
| 13 | const BUILTIN_FUNCTIONS =
|
---|
| 14 | ' abasep abs absint absolute_real_time acos acosh acot acoth acsc acsch activate' +
|
---|
| 15 | ' addcol add_edge add_edges addmatrices addrow add_vertex add_vertices adjacency_matrix' +
|
---|
| 16 | ' adjoin adjoint af agd airy airy_ai airy_bi airy_dai airy_dbi algsys alg_type' +
|
---|
| 17 | ' alias allroots alphacharp alphanumericp amortization %and annuity_fv' +
|
---|
| 18 | ' annuity_pv antid antidiff AntiDifference append appendfile apply apply1 apply2' +
|
---|
| 19 | ' applyb1 apropos args arit_amortization arithmetic arithsum array arrayapply' +
|
---|
| 20 | ' arrayinfo arraymake arraysetapply ascii asec asech asin asinh askinteger' +
|
---|
| 21 | ' asksign assoc assoc_legendre_p assoc_legendre_q assume assume_external_byte_order' +
|
---|
| 22 | ' asympa at atan atan2 atanh atensimp atom atvalue augcoefmatrix augmented_lagrangian_method' +
|
---|
| 23 | ' av average_degree backtrace bars barsplot barsplot_description base64 base64_decode' +
|
---|
| 24 | ' bashindices batch batchload bc2 bdvac belln benefit_cost bern bernpoly bernstein_approx' +
|
---|
| 25 | ' bernstein_expand bernstein_poly bessel bessel_i bessel_j bessel_k bessel_simplify' +
|
---|
| 26 | ' bessel_y beta beta_incomplete beta_incomplete_generalized beta_incomplete_regularized' +
|
---|
| 27 | ' bezout bfallroots bffac bf_find_root bf_fmin_cobyla bfhzeta bfloat bfloatp' +
|
---|
| 28 | ' bfpsi bfpsi0 bfzeta biconnected_components bimetric binomial bipartition' +
|
---|
| 29 | ' block blockmatrixp bode_gain bode_phase bothcoef box boxplot boxplot_description' +
|
---|
| 30 | ' break bug_report build_info|10 buildq build_sample burn cabs canform canten' +
|
---|
| 31 | ' cardinality carg cartan cartesian_product catch cauchy_matrix cbffac cdf_bernoulli' +
|
---|
| 32 | ' cdf_beta cdf_binomial cdf_cauchy cdf_chi2 cdf_continuous_uniform cdf_discrete_uniform' +
|
---|
| 33 | ' cdf_exp cdf_f cdf_gamma cdf_general_finite_discrete cdf_geometric cdf_gumbel' +
|
---|
| 34 | ' cdf_hypergeometric cdf_laplace cdf_logistic cdf_lognormal cdf_negative_binomial' +
|
---|
| 35 | ' cdf_noncentral_chi2 cdf_noncentral_student_t cdf_normal cdf_pareto cdf_poisson' +
|
---|
| 36 | ' cdf_rank_sum cdf_rayleigh cdf_signed_rank cdf_student_t cdf_weibull cdisplay' +
|
---|
| 37 | ' ceiling central_moment cequal cequalignore cf cfdisrep cfexpand cgeodesic' +
|
---|
| 38 | ' cgreaterp cgreaterpignore changename changevar chaosgame charat charfun charfun2' +
|
---|
| 39 | ' charlist charp charpoly chdir chebyshev_t chebyshev_u checkdiv check_overlaps' +
|
---|
| 40 | ' chinese cholesky christof chromatic_index chromatic_number cint circulant_graph' +
|
---|
| 41 | ' clear_edge_weight clear_rules clear_vertex_label clebsch_gordan clebsch_graph' +
|
---|
| 42 | ' clessp clesspignore close closefile cmetric coeff coefmatrix cograd col collapse' +
|
---|
| 43 | ' collectterms columnop columnspace columnswap columnvector combination combine' +
|
---|
| 44 | ' comp2pui compare compfile compile compile_file complement_graph complete_bipartite_graph' +
|
---|
| 45 | ' complete_graph complex_number_p components compose_functions concan concat' +
|
---|
| 46 | ' conjugate conmetderiv connected_components connect_vertices cons constant' +
|
---|
| 47 | ' constantp constituent constvalue cont2part content continuous_freq contortion' +
|
---|
| 48 | ' contour_plot contract contract_edge contragrad contrib_ode convert coord' +
|
---|
| 49 | ' copy copy_file copy_graph copylist copymatrix cor cos cosh cot coth cov cov1' +
|
---|
| 50 | ' covdiff covect covers crc24sum create_graph create_list csc csch csetup cspline' +
|
---|
| 51 | ' ctaylor ct_coordsys ctransform ctranspose cube_graph cuboctahedron_graph' +
|
---|
| 52 | ' cunlisp cv cycle_digraph cycle_graph cylindrical days360 dblint deactivate' +
|
---|
| 53 | ' declare declare_constvalue declare_dimensions declare_fundamental_dimensions' +
|
---|
| 54 | ' declare_fundamental_units declare_qty declare_translated declare_unit_conversion' +
|
---|
| 55 | ' declare_units declare_weights decsym defcon define define_alt_display define_variable' +
|
---|
| 56 | ' defint defmatch defrule defstruct deftaylor degree_sequence del delete deleten' +
|
---|
| 57 | ' delta demo demoivre denom depends derivdegree derivlist describe desolve' +
|
---|
| 58 | ' determinant dfloat dgauss_a dgauss_b dgeev dgemm dgeqrf dgesv dgesvd diag' +
|
---|
| 59 | ' diagmatrix diag_matrix diagmatrixp diameter diff digitcharp dimacs_export' +
|
---|
| 60 | ' dimacs_import dimension dimensionless dimensions dimensions_as_list direct' +
|
---|
| 61 | ' directory discrete_freq disjoin disjointp disolate disp dispcon dispform' +
|
---|
| 62 | ' dispfun dispJordan display disprule dispterms distrib divide divisors divsum' +
|
---|
| 63 | ' dkummer_m dkummer_u dlange dodecahedron_graph dotproduct dotsimp dpart' +
|
---|
| 64 | ' draw draw2d draw3d drawdf draw_file draw_graph dscalar echelon edge_coloring' +
|
---|
| 65 | ' edge_connectivity edges eigens_by_jacobi eigenvalues eigenvectors eighth' +
|
---|
| 66 | ' einstein eivals eivects elapsed_real_time elapsed_run_time ele2comp ele2polynome' +
|
---|
| 67 | ' ele2pui elem elementp elevation_grid elim elim_allbut eliminate eliminate_using' +
|
---|
| 68 | ' ellipse elliptic_e elliptic_ec elliptic_eu elliptic_f elliptic_kc elliptic_pi' +
|
---|
| 69 | ' ematrix empty_graph emptyp endcons entermatrix entertensor entier equal equalp' +
|
---|
| 70 | ' equiv_classes erf erfc erf_generalized erfi errcatch error errormsg errors' +
|
---|
| 71 | ' euler ev eval_string evenp every evolution evolution2d evundiff example exp' +
|
---|
| 72 | ' expand expandwrt expandwrt_factored expint expintegral_chi expintegral_ci' +
|
---|
| 73 | ' expintegral_e expintegral_e1 expintegral_ei expintegral_e_simplify expintegral_li' +
|
---|
| 74 | ' expintegral_shi expintegral_si explicit explose exponentialize express expt' +
|
---|
| 75 | ' exsec extdiff extract_linear_equations extremal_subset ezgcd %f f90 facsum' +
|
---|
| 76 | ' factcomb factor factorfacsum factorial factorout factorsum facts fast_central_elements' +
|
---|
| 77 | ' fast_linsolve fasttimes featurep fernfale fft fib fibtophi fifth filename_merge' +
|
---|
| 78 | ' file_search file_type fillarray findde find_root find_root_abs find_root_error' +
|
---|
| 79 | ' find_root_rel first fix flatten flength float floatnump floor flower_snark' +
|
---|
| 80 | ' flush flush1deriv flushd flushnd flush_output fmin_cobyla forget fortran' +
|
---|
| 81 | ' fourcos fourexpand fourier fourier_elim fourint fourintcos fourintsin foursimp' +
|
---|
| 82 | ' foursin fourth fposition frame_bracket freeof freshline fresnel_c fresnel_s' +
|
---|
| 83 | ' from_adjacency_matrix frucht_graph full_listify fullmap fullmapl fullratsimp' +
|
---|
| 84 | ' fullratsubst fullsetify funcsolve fundamental_dimensions fundamental_units' +
|
---|
| 85 | ' fundef funmake funp fv g0 g1 gamma gamma_greek gamma_incomplete gamma_incomplete_generalized' +
|
---|
| 86 | ' gamma_incomplete_regularized gauss gauss_a gauss_b gaussprob gcd gcdex gcdivide' +
|
---|
| 87 | ' gcfac gcfactor gd generalized_lambert_w genfact gen_laguerre genmatrix gensym' +
|
---|
| 88 | ' geo_amortization geo_annuity_fv geo_annuity_pv geomap geometric geometric_mean' +
|
---|
| 89 | ' geosum get getcurrentdirectory get_edge_weight getenv get_lu_factors get_output_stream_string' +
|
---|
| 90 | ' get_pixel get_plot_option get_tex_environment get_tex_environment_default' +
|
---|
| 91 | ' get_vertex_label gfactor gfactorsum ggf girth global_variances gn gnuplot_close' +
|
---|
| 92 | ' gnuplot_replot gnuplot_reset gnuplot_restart gnuplot_start go Gosper GosperSum' +
|
---|
| 93 | ' gr2d gr3d gradef gramschmidt graph6_decode graph6_encode graph6_export graph6_import' +
|
---|
| 94 | ' graph_center graph_charpoly graph_eigenvalues graph_flow graph_order graph_periphery' +
|
---|
| 95 | ' graph_product graph_size graph_union great_rhombicosidodecahedron_graph great_rhombicuboctahedron_graph' +
|
---|
| 96 | ' grid_graph grind grobner_basis grotzch_graph hamilton_cycle hamilton_path' +
|
---|
| 97 | ' hankel hankel_1 hankel_2 harmonic harmonic_mean hav heawood_graph hermite' +
|
---|
| 98 | ' hessian hgfred hilbertmap hilbert_matrix hipow histogram histogram_description' +
|
---|
| 99 | ' hodge horner hypergeometric i0 i1 %ibes ic1 ic2 ic_convert ichr1 ichr2 icosahedron_graph' +
|
---|
| 100 | ' icosidodecahedron_graph icurvature ident identfor identity idiff idim idummy' +
|
---|
| 101 | ' ieqn %if ifactors iframes ifs igcdex igeodesic_coords ilt image imagpart' +
|
---|
| 102 | ' imetric implicit implicit_derivative implicit_plot indexed_tensor indices' +
|
---|
| 103 | ' induced_subgraph inferencep inference_result infix info_display init_atensor' +
|
---|
| 104 | ' init_ctensor in_neighbors innerproduct inpart inprod inrt integerp integer_partitions' +
|
---|
| 105 | ' integrate intersect intersection intervalp intopois intosum invariant1 invariant2' +
|
---|
| 106 | ' inverse_fft inverse_jacobi_cd inverse_jacobi_cn inverse_jacobi_cs inverse_jacobi_dc' +
|
---|
| 107 | ' inverse_jacobi_dn inverse_jacobi_ds inverse_jacobi_nc inverse_jacobi_nd inverse_jacobi_ns' +
|
---|
| 108 | ' inverse_jacobi_sc inverse_jacobi_sd inverse_jacobi_sn invert invert_by_adjoint' +
|
---|
| 109 | ' invert_by_lu inv_mod irr is is_biconnected is_bipartite is_connected is_digraph' +
|
---|
| 110 | ' is_edge_in_graph is_graph is_graph_or_digraph ishow is_isomorphic isolate' +
|
---|
| 111 | ' isomorphism is_planar isqrt isreal_p is_sconnected is_tree is_vertex_in_graph' +
|
---|
| 112 | ' items_inference %j j0 j1 jacobi jacobian jacobi_cd jacobi_cn jacobi_cs jacobi_dc' +
|
---|
| 113 | ' jacobi_dn jacobi_ds jacobi_nc jacobi_nd jacobi_ns jacobi_p jacobi_sc jacobi_sd' +
|
---|
| 114 | ' jacobi_sn JF jn join jordan julia julia_set julia_sin %k kdels kdelta kill' +
|
---|
| 115 | ' killcontext kostka kron_delta kronecker_product kummer_m kummer_u kurtosis' +
|
---|
| 116 | ' kurtosis_bernoulli kurtosis_beta kurtosis_binomial kurtosis_chi2 kurtosis_continuous_uniform' +
|
---|
| 117 | ' kurtosis_discrete_uniform kurtosis_exp kurtosis_f kurtosis_gamma kurtosis_general_finite_discrete' +
|
---|
| 118 | ' kurtosis_geometric kurtosis_gumbel kurtosis_hypergeometric kurtosis_laplace' +
|
---|
| 119 | ' kurtosis_logistic kurtosis_lognormal kurtosis_negative_binomial kurtosis_noncentral_chi2' +
|
---|
| 120 | ' kurtosis_noncentral_student_t kurtosis_normal kurtosis_pareto kurtosis_poisson' +
|
---|
| 121 | ' kurtosis_rayleigh kurtosis_student_t kurtosis_weibull label labels lagrange' +
|
---|
| 122 | ' laguerre lambda lambert_w laplace laplacian_matrix last lbfgs lc2kdt lcharp' +
|
---|
| 123 | ' lc_l lcm lc_u ldefint ldisp ldisplay legendre_p legendre_q leinstein length' +
|
---|
| 124 | ' let letrules letsimp levi_civita lfreeof lgtreillis lhs li liediff limit' +
|
---|
| 125 | ' Lindstedt linear linearinterpol linear_program linear_regression line_graph' +
|
---|
| 126 | ' linsolve listarray list_correlations listify list_matrix_entries list_nc_monomials' +
|
---|
| 127 | ' listoftens listofvars listp lmax lmin load loadfile local locate_matrix_entry' +
|
---|
| 128 | ' log logcontract log_gamma lopow lorentz_gauge lowercasep lpart lratsubst' +
|
---|
| 129 | ' lreduce lriemann lsquares_estimates lsquares_estimates_approximate lsquares_estimates_exact' +
|
---|
| 130 | ' lsquares_mse lsquares_residual_mse lsquares_residuals lsum ltreillis lu_backsub' +
|
---|
| 131 | ' lucas lu_factor %m macroexpand macroexpand1 make_array makebox makefact makegamma' +
|
---|
| 132 | ' make_graph make_level_picture makelist makeOrders make_poly_continent make_poly_country' +
|
---|
| 133 | ' make_polygon make_random_state make_rgb_picture makeset make_string_input_stream' +
|
---|
| 134 | ' make_string_output_stream make_transform mandelbrot mandelbrot_set map mapatom' +
|
---|
| 135 | ' maplist matchdeclare matchfix mat_cond mat_fullunblocker mat_function mathml_display' +
|
---|
| 136 | ' mat_norm matrix matrixmap matrixp matrix_size mattrace mat_trace mat_unblocker' +
|
---|
| 137 | ' max max_clique max_degree max_flow maximize_lp max_independent_set max_matching' +
|
---|
| 138 | ' maybe md5sum mean mean_bernoulli mean_beta mean_binomial mean_chi2 mean_continuous_uniform' +
|
---|
| 139 | ' mean_deviation mean_discrete_uniform mean_exp mean_f mean_gamma mean_general_finite_discrete' +
|
---|
| 140 | ' mean_geometric mean_gumbel mean_hypergeometric mean_laplace mean_logistic' +
|
---|
| 141 | ' mean_lognormal mean_negative_binomial mean_noncentral_chi2 mean_noncentral_student_t' +
|
---|
| 142 | ' mean_normal mean_pareto mean_poisson mean_rayleigh mean_student_t mean_weibull' +
|
---|
| 143 | ' median median_deviation member mesh metricexpandall mgf1_sha1 min min_degree' +
|
---|
| 144 | ' min_edge_cut minfactorial minimalPoly minimize_lp minimum_spanning_tree minor' +
|
---|
| 145 | ' minpack_lsquares minpack_solve min_vertex_cover min_vertex_cut mkdir mnewton' +
|
---|
| 146 | ' mod mode_declare mode_identity ModeMatrix moebius mon2schur mono monomial_dimensions' +
|
---|
| 147 | ' multibernstein_poly multi_display_for_texinfo multi_elem multinomial multinomial_coeff' +
|
---|
| 148 | ' multi_orbit multiplot_mode multi_pui multsym multthru mycielski_graph nary' +
|
---|
| 149 | ' natural_unit nc_degree ncexpt ncharpoly negative_picture neighbors new newcontext' +
|
---|
| 150 | ' newdet new_graph newline newton new_variable next_prime nicedummies niceindices' +
|
---|
| 151 | ' ninth nofix nonarray noncentral_moment nonmetricity nonnegintegerp nonscalarp' +
|
---|
| 152 | ' nonzeroandfreeof notequal nounify nptetrad npv nroots nterms ntermst' +
|
---|
| 153 | ' nthroot nullity nullspace num numbered_boundaries numberp number_to_octets' +
|
---|
| 154 | ' num_distinct_partitions numerval numfactor num_partitions nusum nzeta nzetai' +
|
---|
| 155 | ' nzetar octets_to_number octets_to_oid odd_girth oddp ode2 ode_check odelin' +
|
---|
| 156 | ' oid_to_octets op opena opena_binary openr openr_binary openw openw_binary' +
|
---|
| 157 | ' operatorp opsubst optimize %or orbit orbits ordergreat ordergreatp orderless' +
|
---|
| 158 | ' orderlessp orthogonal_complement orthopoly_recur orthopoly_weight outermap' +
|
---|
| 159 | ' out_neighbors outofpois pade parabolic_cylinder_d parametric parametric_surface' +
|
---|
| 160 | ' parg parGosper parse_string parse_timedate part part2cont partfrac partition' +
|
---|
| 161 | ' partition_set partpol path_digraph path_graph pathname_directory pathname_name' +
|
---|
| 162 | ' pathname_type pdf_bernoulli pdf_beta pdf_binomial pdf_cauchy pdf_chi2 pdf_continuous_uniform' +
|
---|
| 163 | ' pdf_discrete_uniform pdf_exp pdf_f pdf_gamma pdf_general_finite_discrete' +
|
---|
| 164 | ' pdf_geometric pdf_gumbel pdf_hypergeometric pdf_laplace pdf_logistic pdf_lognormal' +
|
---|
| 165 | ' pdf_negative_binomial pdf_noncentral_chi2 pdf_noncentral_student_t pdf_normal' +
|
---|
| 166 | ' pdf_pareto pdf_poisson pdf_rank_sum pdf_rayleigh pdf_signed_rank pdf_student_t' +
|
---|
| 167 | ' pdf_weibull pearson_skewness permanent permut permutation permutations petersen_graph' +
|
---|
| 168 | ' petrov pickapart picture_equalp picturep piechart piechart_description planar_embedding' +
|
---|
| 169 | ' playback plog plot2d plot3d plotdf ploteq plsquares pochhammer points poisdiff' +
|
---|
| 170 | ' poisexpt poisint poismap poisplus poissimp poissubst poistimes poistrim polar' +
|
---|
| 171 | ' polarform polartorect polar_to_xy poly_add poly_buchberger poly_buchberger_criterion' +
|
---|
| 172 | ' poly_colon_ideal poly_content polydecomp poly_depends_p poly_elimination_ideal' +
|
---|
| 173 | ' poly_exact_divide poly_expand poly_expt poly_gcd polygon poly_grobner poly_grobner_equal' +
|
---|
| 174 | ' poly_grobner_member poly_grobner_subsetp poly_ideal_intersection poly_ideal_polysaturation' +
|
---|
| 175 | ' poly_ideal_polysaturation1 poly_ideal_saturation poly_ideal_saturation1 poly_lcm' +
|
---|
| 176 | ' poly_minimization polymod poly_multiply polynome2ele polynomialp poly_normal_form' +
|
---|
| 177 | ' poly_normalize poly_normalize_list poly_polysaturation_extension poly_primitive_part' +
|
---|
| 178 | ' poly_pseudo_divide poly_reduced_grobner poly_reduction poly_saturation_extension' +
|
---|
| 179 | ' poly_s_polynomial poly_subtract polytocompanion pop postfix potential power_mod' +
|
---|
| 180 | ' powerseries powerset prefix prev_prime primep primes principal_components' +
|
---|
| 181 | ' print printf printfile print_graph printpois printprops prodrac product properties' +
|
---|
| 182 | ' propvars psi psubst ptriangularize pui pui2comp pui2ele pui2polynome pui_direct' +
|
---|
| 183 | ' puireduc push put pv qput qrange qty quad_control quad_qag quad_qagi quad_qagp' +
|
---|
| 184 | ' quad_qags quad_qawc quad_qawf quad_qawo quad_qaws quadrilateral quantile' +
|
---|
| 185 | ' quantile_bernoulli quantile_beta quantile_binomial quantile_cauchy quantile_chi2' +
|
---|
| 186 | ' quantile_continuous_uniform quantile_discrete_uniform quantile_exp quantile_f' +
|
---|
| 187 | ' quantile_gamma quantile_general_finite_discrete quantile_geometric quantile_gumbel' +
|
---|
| 188 | ' quantile_hypergeometric quantile_laplace quantile_logistic quantile_lognormal' +
|
---|
| 189 | ' quantile_negative_binomial quantile_noncentral_chi2 quantile_noncentral_student_t' +
|
---|
| 190 | ' quantile_normal quantile_pareto quantile_poisson quantile_rayleigh quantile_student_t' +
|
---|
| 191 | ' quantile_weibull quartile_skewness quit qunit quotient racah_v racah_w radcan' +
|
---|
| 192 | ' radius random random_bernoulli random_beta random_binomial random_bipartite_graph' +
|
---|
| 193 | ' random_cauchy random_chi2 random_continuous_uniform random_digraph random_discrete_uniform' +
|
---|
| 194 | ' random_exp random_f random_gamma random_general_finite_discrete random_geometric' +
|
---|
| 195 | ' random_graph random_graph1 random_gumbel random_hypergeometric random_laplace' +
|
---|
| 196 | ' random_logistic random_lognormal random_negative_binomial random_network' +
|
---|
| 197 | ' random_noncentral_chi2 random_noncentral_student_t random_normal random_pareto' +
|
---|
| 198 | ' random_permutation random_poisson random_rayleigh random_regular_graph random_student_t' +
|
---|
| 199 | ' random_tournament random_tree random_weibull range rank rat ratcoef ratdenom' +
|
---|
| 200 | ' ratdiff ratdisrep ratexpand ratinterpol rational rationalize ratnumer ratnump' +
|
---|
| 201 | ' ratp ratsimp ratsubst ratvars ratweight read read_array read_binary_array' +
|
---|
| 202 | ' read_binary_list read_binary_matrix readbyte readchar read_hashed_array readline' +
|
---|
| 203 | ' read_list read_matrix read_nested_list readonly read_xpm real_imagpart_to_conjugate' +
|
---|
| 204 | ' realpart realroots rearray rectangle rectform rectform_log_if_constant recttopolar' +
|
---|
| 205 | ' rediff reduce_consts reduce_order region region_boundaries region_boundaries_plus' +
|
---|
| 206 | ' rem remainder remarray rembox remcomps remcon remcoord remfun remfunction' +
|
---|
| 207 | ' remlet remove remove_constvalue remove_dimensions remove_edge remove_fundamental_dimensions' +
|
---|
| 208 | ' remove_fundamental_units remove_plot_option remove_vertex rempart remrule' +
|
---|
| 209 | ' remsym remvalue rename rename_file reset reset_displays residue resolvante' +
|
---|
| 210 | ' resolvante_alternee1 resolvante_bipartite resolvante_diedrale resolvante_klein' +
|
---|
| 211 | ' resolvante_klein3 resolvante_produit_sym resolvante_unitaire resolvante_vierer' +
|
---|
| 212 | ' rest resultant return reveal reverse revert revert2 rgb2level rhs ricci riemann' +
|
---|
| 213 | ' rinvariant risch rk rmdir rncombine romberg room rootscontract round row' +
|
---|
| 214 | ' rowop rowswap rreduce run_testsuite %s save saving scalarp scaled_bessel_i' +
|
---|
| 215 | ' scaled_bessel_i0 scaled_bessel_i1 scalefactors scanmap scatterplot scatterplot_description' +
|
---|
| 216 | ' scene schur2comp sconcat scopy scsimp scurvature sdowncase sec sech second' +
|
---|
| 217 | ' sequal sequalignore set_alt_display setdifference set_draw_defaults set_edge_weight' +
|
---|
| 218 | ' setelmx setequalp setify setp set_partitions set_plot_option set_prompt set_random_state' +
|
---|
| 219 | ' set_tex_environment set_tex_environment_default setunits setup_autoload set_up_dot_simplifications' +
|
---|
| 220 | ' set_vertex_label seventh sexplode sf sha1sum sha256sum shortest_path shortest_weighted_path' +
|
---|
| 221 | ' show showcomps showratvars sierpinskiale sierpinskimap sign signum similaritytransform' +
|
---|
| 222 | ' simp_inequality simplify_sum simplode simpmetderiv simtran sin sinh sinsert' +
|
---|
| 223 | ' sinvertcase sixth skewness skewness_bernoulli skewness_beta skewness_binomial' +
|
---|
| 224 | ' skewness_chi2 skewness_continuous_uniform skewness_discrete_uniform skewness_exp' +
|
---|
| 225 | ' skewness_f skewness_gamma skewness_general_finite_discrete skewness_geometric' +
|
---|
| 226 | ' skewness_gumbel skewness_hypergeometric skewness_laplace skewness_logistic' +
|
---|
| 227 | ' skewness_lognormal skewness_negative_binomial skewness_noncentral_chi2 skewness_noncentral_student_t' +
|
---|
| 228 | ' skewness_normal skewness_pareto skewness_poisson skewness_rayleigh skewness_student_t' +
|
---|
| 229 | ' skewness_weibull slength smake small_rhombicosidodecahedron_graph small_rhombicuboctahedron_graph' +
|
---|
| 230 | ' smax smin smismatch snowmap snub_cube_graph snub_dodecahedron_graph solve' +
|
---|
| 231 | ' solve_rec solve_rec_rat some somrac sort sparse6_decode sparse6_encode sparse6_export' +
|
---|
| 232 | ' sparse6_import specint spherical spherical_bessel_j spherical_bessel_y spherical_hankel1' +
|
---|
| 233 | ' spherical_hankel2 spherical_harmonic spherical_to_xyz splice split sposition' +
|
---|
| 234 | ' sprint sqfr sqrt sqrtdenest sremove sremovefirst sreverse ssearch ssort sstatus' +
|
---|
| 235 | ' ssubst ssubstfirst staircase standardize standardize_inverse_trig starplot' +
|
---|
| 236 | ' starplot_description status std std1 std_bernoulli std_beta std_binomial' +
|
---|
| 237 | ' std_chi2 std_continuous_uniform std_discrete_uniform std_exp std_f std_gamma' +
|
---|
| 238 | ' std_general_finite_discrete std_geometric std_gumbel std_hypergeometric std_laplace' +
|
---|
| 239 | ' std_logistic std_lognormal std_negative_binomial std_noncentral_chi2 std_noncentral_student_t' +
|
---|
| 240 | ' std_normal std_pareto std_poisson std_rayleigh std_student_t std_weibull' +
|
---|
| 241 | ' stemplot stirling stirling1 stirling2 strim striml strimr string stringout' +
|
---|
| 242 | ' stringp strong_components struve_h struve_l sublis sublist sublist_indices' +
|
---|
| 243 | ' submatrix subsample subset subsetp subst substinpart subst_parallel substpart' +
|
---|
| 244 | ' substring subvar subvarp sum sumcontract summand_to_rec supcase supcontext' +
|
---|
| 245 | ' symbolp symmdifference symmetricp system take_channel take_inference tan' +
|
---|
| 246 | ' tanh taylor taylorinfo taylorp taylor_simplifier taytorat tcl_output tcontract' +
|
---|
| 247 | ' tellrat tellsimp tellsimpafter tentex tenth test_mean test_means_difference' +
|
---|
| 248 | ' test_normality test_proportion test_proportions_difference test_rank_sum' +
|
---|
| 249 | ' test_sign test_signed_rank test_variance test_variance_ratio tex tex1 tex_display' +
|
---|
| 250 | ' texput %th third throw time timedate timer timer_info tldefint tlimit todd_coxeter' +
|
---|
| 251 | ' toeplitz tokens to_lisp topological_sort to_poly to_poly_solve totaldisrep' +
|
---|
| 252 | ' totalfourier totient tpartpol trace tracematrix trace_options transform_sample' +
|
---|
| 253 | ' translate translate_file transpose treefale tree_reduce treillis treinat' +
|
---|
| 254 | ' triangle triangularize trigexpand trigrat trigreduce trigsimp trunc truncate' +
|
---|
| 255 | ' truncated_cube_graph truncated_dodecahedron_graph truncated_icosahedron_graph' +
|
---|
| 256 | ' truncated_tetrahedron_graph tr_warnings_get tube tutte_graph ueivects uforget' +
|
---|
| 257 | ' ultraspherical underlying_graph undiff union unique uniteigenvectors unitp' +
|
---|
| 258 | ' units unit_step unitvector unorder unsum untellrat untimer' +
|
---|
| 259 | ' untrace uppercasep uricci uriemann uvect vandermonde_matrix var var1 var_bernoulli' +
|
---|
| 260 | ' var_beta var_binomial var_chi2 var_continuous_uniform var_discrete_uniform' +
|
---|
| 261 | ' var_exp var_f var_gamma var_general_finite_discrete var_geometric var_gumbel' +
|
---|
| 262 | ' var_hypergeometric var_laplace var_logistic var_lognormal var_negative_binomial' +
|
---|
| 263 | ' var_noncentral_chi2 var_noncentral_student_t var_normal var_pareto var_poisson' +
|
---|
| 264 | ' var_rayleigh var_student_t var_weibull vector vectorpotential vectorsimp' +
|
---|
| 265 | ' verbify vers vertex_coloring vertex_connectivity vertex_degree vertex_distance' +
|
---|
| 266 | ' vertex_eccentricity vertex_in_degree vertex_out_degree vertices vertices_to_cycle' +
|
---|
| 267 | ' vertices_to_path %w weyl wheel_graph wiener_index wigner_3j wigner_6j' +
|
---|
| 268 | ' wigner_9j with_stdout write_binary_data writebyte write_data writefile wronskian' +
|
---|
| 269 | ' xreduce xthru %y Zeilberger zeroequiv zerofor zeromatrix zeromatrixp zeta' +
|
---|
| 270 | ' zgeev zheev zlange zn_add_table zn_carmichael_lambda zn_characteristic_factors' +
|
---|
| 271 | ' zn_determinant zn_factor_generators zn_invert_by_lu zn_log zn_mult_table' +
|
---|
| 272 | ' absboxchar activecontexts adapt_depth additive adim aform algebraic' +
|
---|
| 273 | ' algepsilon algexact aliases allbut all_dotsimp_denoms allocation allsym alphabetic' +
|
---|
| 274 | ' animation antisymmetric arrays askexp assume_pos assume_pos_pred assumescalar' +
|
---|
| 275 | ' asymbol atomgrad atrig1 axes axis_3d axis_bottom axis_left axis_right axis_top' +
|
---|
| 276 | ' azimuth background background_color backsubst berlefact bernstein_explicit' +
|
---|
| 277 | ' besselexpand beta_args_sum_to_integer beta_expand bftorat bftrunc bindtest' +
|
---|
| 278 | ' border boundaries_array box boxchar breakup %c capping cauchysum cbrange' +
|
---|
| 279 | ' cbtics center cflength cframe_flag cnonmet_flag color color_bar color_bar_tics' +
|
---|
| 280 | ' colorbox columns commutative complex cone context contexts contour contour_levels' +
|
---|
| 281 | ' cosnpiflag ctaypov ctaypt ctayswitch ctayvar ct_coords ctorsion_flag ctrgsimp' +
|
---|
| 282 | ' cube current_let_rule_package cylinder data_file_name debugmode decreasing' +
|
---|
| 283 | ' default_let_rule_package delay dependencies derivabbrev derivsubst detout' +
|
---|
| 284 | ' diagmetric diff dim dimensions dispflag display2d|10 display_format_internal' +
|
---|
| 285 | ' distribute_over doallmxops domain domxexpt domxmxops domxnctimes dontfactor' +
|
---|
| 286 | ' doscmxops doscmxplus dot0nscsimp dot0simp dot1simp dotassoc dotconstrules' +
|
---|
| 287 | ' dotdistrib dotexptsimp dotident dotscrules draw_graph_program draw_realpart' +
|
---|
| 288 | ' edge_color edge_coloring edge_partition edge_type edge_width %edispflag' +
|
---|
| 289 | ' elevation %emode endphi endtheta engineering_format_floats enhanced3d %enumer' +
|
---|
| 290 | ' epsilon_lp erfflag erf_representation errormsg error_size error_syms error_type' +
|
---|
| 291 | ' %e_to_numlog eval even evenfun evflag evfun ev_point expandwrt_denom expintexpand' +
|
---|
| 292 | ' expintrep expon expop exptdispflag exptisolate exptsubst facexpand facsum_combine' +
|
---|
| 293 | ' factlim factorflag factorial_expand factors_only fb feature features' +
|
---|
| 294 | ' file_name file_output_append file_search_demo file_search_lisp file_search_maxima|10' +
|
---|
| 295 | ' file_search_tests file_search_usage file_type_lisp file_type_maxima|10 fill_color' +
|
---|
| 296 | ' fill_density filled_func fixed_vertices flipflag float2bf font font_size' +
|
---|
| 297 | ' fortindent fortspaces fpprec fpprintprec functions gamma_expand gammalim' +
|
---|
| 298 | ' gdet genindex gensumnum GGFCFMAX GGFINFINITY globalsolve gnuplot_command' +
|
---|
| 299 | ' gnuplot_curve_styles gnuplot_curve_titles gnuplot_default_term_command gnuplot_dumb_term_command' +
|
---|
| 300 | ' gnuplot_file_args gnuplot_file_name gnuplot_out_file gnuplot_pdf_term_command' +
|
---|
| 301 | ' gnuplot_pm3d gnuplot_png_term_command gnuplot_postamble gnuplot_preamble' +
|
---|
| 302 | ' gnuplot_ps_term_command gnuplot_svg_term_command gnuplot_term gnuplot_view_args' +
|
---|
| 303 | ' Gosper_in_Zeilberger gradefs grid grid2d grind halfangles head_angle head_both' +
|
---|
| 304 | ' head_length head_type height hypergeometric_representation %iargs ibase' +
|
---|
| 305 | ' icc1 icc2 icounter idummyx ieqnprint ifb ifc1 ifc2 ifg ifgi ifr iframe_bracket_form' +
|
---|
| 306 | ' ifri igeowedge_flag ikt1 ikt2 imaginary inchar increasing infeval' +
|
---|
| 307 | ' infinity inflag infolists inm inmc1 inmc2 intanalysis integer integervalued' +
|
---|
| 308 | ' integrate_use_rootsof integration_constant integration_constant_counter interpolate_color' +
|
---|
| 309 | ' intfaclim ip_grid ip_grid_in irrational isolate_wrt_times iterations itr' +
|
---|
| 310 | ' julia_parameter %k1 %k2 keepfloat key key_pos kinvariant kt label label_alignment' +
|
---|
| 311 | ' label_orientation labels lassociative lbfgs_ncorrections lbfgs_nfeval_max' +
|
---|
| 312 | ' leftjust legend letrat let_rule_packages lfg lg lhospitallim limsubst linear' +
|
---|
| 313 | ' linear_solver linechar linel|10 linenum line_type linewidth line_width linsolve_params' +
|
---|
| 314 | ' linsolvewarn lispdisp listarith listconstvars listdummyvars lmxchar load_pathname' +
|
---|
| 315 | ' loadprint logabs logarc logcb logconcoeffp logexpand lognegint logsimp logx' +
|
---|
| 316 | ' logx_secondary logy logy_secondary logz lriem m1pbranch macroexpansion macros' +
|
---|
| 317 | ' mainvar manual_demo maperror mapprint matrix_element_add matrix_element_mult' +
|
---|
| 318 | ' matrix_element_transpose maxapplydepth maxapplyheight maxima_tempdir|10 maxima_userdir|10' +
|
---|
| 319 | ' maxnegex MAX_ORD maxposex maxpsifracdenom maxpsifracnum maxpsinegint maxpsiposint' +
|
---|
| 320 | ' maxtayorder mesh_lines_color method mod_big_prime mode_check_errorp' +
|
---|
| 321 | ' mode_checkp mode_check_warnp mod_test mod_threshold modular_linear_solver' +
|
---|
| 322 | ' modulus multiplicative multiplicities myoptions nary negdistrib negsumdispflag' +
|
---|
| 323 | ' newline newtonepsilon newtonmaxiter nextlayerfactor niceindicespref nm nmc' +
|
---|
| 324 | ' noeval nolabels nonegative_lp noninteger nonscalar noun noundisp nouns np' +
|
---|
| 325 | ' npi nticks ntrig numer numer_pbranch obase odd oddfun opacity opproperties' +
|
---|
| 326 | ' opsubst optimprefix optionset orientation origin orthopoly_returns_intervals' +
|
---|
| 327 | ' outative outchar packagefile palette partswitch pdf_file pfeformat phiresolution' +
|
---|
| 328 | ' %piargs piece pivot_count_sx pivot_max_sx plot_format plot_options plot_realpart' +
|
---|
| 329 | ' png_file pochhammer_max_index points pointsize point_size points_joined point_type' +
|
---|
| 330 | ' poislim poisson poly_coefficient_ring poly_elimination_order polyfactor poly_grobner_algorithm' +
|
---|
| 331 | ' poly_grobner_debug poly_monomial_order poly_primary_elimination_order poly_return_term_list' +
|
---|
| 332 | ' poly_secondary_elimination_order poly_top_reduction_only posfun position' +
|
---|
| 333 | ' powerdisp pred prederror primep_number_of_tests product_use_gamma program' +
|
---|
| 334 | ' programmode promote_float_to_bigfloat prompt proportional_axes props psexpand' +
|
---|
| 335 | ' ps_file radexpand radius radsubstflag rassociative ratalgdenom ratchristof' +
|
---|
| 336 | ' ratdenomdivide rateinstein ratepsilon ratfac rational ratmx ratprint ratriemann' +
|
---|
| 337 | ' ratsimpexpons ratvarswitch ratweights ratweyl ratwtlvl real realonly redraw' +
|
---|
| 338 | ' refcheck resolution restart resultant ric riem rmxchar %rnum_list rombergabs' +
|
---|
| 339 | ' rombergit rombergmin rombergtol rootsconmode rootsepsilon run_viewer same_xy' +
|
---|
| 340 | ' same_xyz savedef savefactors scalar scalarmatrixp scale scale_lp setcheck' +
|
---|
| 341 | ' setcheckbreak setval show_edge_color show_edges show_edge_type show_edge_width' +
|
---|
| 342 | ' show_id show_label showtime show_vertex_color show_vertex_size show_vertex_type' +
|
---|
| 343 | ' show_vertices show_weight simp simplified_output simplify_products simpproduct' +
|
---|
| 344 | ' simpsum sinnpiflag solvedecomposes solveexplicit solvefactors solvenullwarn' +
|
---|
| 345 | ' solveradcan solvetrigwarn space sparse sphere spring_embedding_depth sqrtdispflag' +
|
---|
| 346 | ' stardisp startphi starttheta stats_numer stringdisp structures style sublis_apply_lambda' +
|
---|
| 347 | ' subnumsimp sumexpand sumsplitfact surface surface_hide svg_file symmetric' +
|
---|
| 348 | ' tab taylordepth taylor_logexpand taylor_order_coefficients taylor_truncate_polynomials' +
|
---|
| 349 | ' tensorkill terminal testsuite_files thetaresolution timer_devalue title tlimswitch' +
|
---|
| 350 | ' tr track transcompile transform transform_xy translate_fast_arrays transparent' +
|
---|
| 351 | ' transrun tr_array_as_ref tr_bound_function_applyp tr_file_tty_messagesp tr_float_can_branch_complex' +
|
---|
| 352 | ' tr_function_call_default trigexpandplus trigexpandtimes triginverses trigsign' +
|
---|
| 353 | ' trivial_solutions tr_numer tr_optimize_max_loop tr_semicompile tr_state_vars' +
|
---|
| 354 | ' tr_warn_bad_function_calls tr_warn_fexpr tr_warn_meval tr_warn_mode' +
|
---|
| 355 | ' tr_warn_undeclared tr_warn_undefined_variable tstep ttyoff tube_extremes' +
|
---|
| 356 | ' ufg ug %unitexpand unit_vectors uric uriem use_fast_arrays user_preamble' +
|
---|
| 357 | ' usersetunits values vect_cross verbose vertex_color vertex_coloring vertex_partition' +
|
---|
| 358 | ' vertex_size vertex_type view warnings weyl width windowname windowtitle wired_surface' +
|
---|
| 359 | ' wireframe xaxis xaxis_color xaxis_secondary xaxis_type xaxis_width xlabel' +
|
---|
| 360 | ' xlabel_secondary xlength xrange xrange_secondary xtics xtics_axis xtics_rotate' +
|
---|
| 361 | ' xtics_rotate_secondary xtics_secondary xtics_secondary_axis xu_grid x_voxel' +
|
---|
| 362 | ' xy_file xyplane xy_scale yaxis yaxis_color yaxis_secondary yaxis_type yaxis_width' +
|
---|
| 363 | ' ylabel ylabel_secondary ylength yrange yrange_secondary ytics ytics_axis' +
|
---|
| 364 | ' ytics_rotate ytics_rotate_secondary ytics_secondary ytics_secondary_axis' +
|
---|
| 365 | ' yv_grid y_voxel yx_ratio zaxis zaxis_color zaxis_type zaxis_width zeroa zerob' +
|
---|
| 366 | ' zerobern zeta%pi zlabel zlabel_rotate zlength zmin zn_primroot_limit zn_primroot_pretest';
|
---|
| 367 | const SYMBOLS = '_ __ %|0 %%|0';
|
---|
| 368 |
|
---|
| 369 | return {
|
---|
| 370 | name: 'Maxima',
|
---|
| 371 | keywords: {
|
---|
| 372 | $pattern: '[A-Za-z_%][0-9A-Za-z_%]*',
|
---|
| 373 | keyword: KEYWORDS,
|
---|
| 374 | literal: LITERALS,
|
---|
| 375 | built_in: BUILTIN_FUNCTIONS,
|
---|
| 376 | symbol: SYMBOLS
|
---|
| 377 | },
|
---|
| 378 | contains: [
|
---|
| 379 | {
|
---|
| 380 | className: 'comment',
|
---|
| 381 | begin: '/\\*',
|
---|
| 382 | end: '\\*/',
|
---|
| 383 | contains: [ 'self' ]
|
---|
| 384 | },
|
---|
| 385 | hljs.QUOTE_STRING_MODE,
|
---|
| 386 | {
|
---|
| 387 | className: 'number',
|
---|
| 388 | relevance: 0,
|
---|
| 389 | variants: [
|
---|
| 390 | {
|
---|
| 391 | // float number w/ exponent
|
---|
| 392 | // hmm, I wonder if we ought to include other exponent markers?
|
---|
| 393 | begin: '\\b(\\d+|\\d+\\.|\\.\\d+|\\d+\\.\\d+)[Ee][-+]?\\d+\\b'
|
---|
| 394 | },
|
---|
| 395 | {
|
---|
| 396 | // bigfloat number
|
---|
| 397 | begin: '\\b(\\d+|\\d+\\.|\\.\\d+|\\d+\\.\\d+)[Bb][-+]?\\d+\\b',
|
---|
| 398 | relevance: 10
|
---|
| 399 | },
|
---|
| 400 | {
|
---|
| 401 | // float number w/out exponent
|
---|
| 402 | // Doesn't seem to recognize floats which start with '.'
|
---|
| 403 | begin: '\\b(\\.\\d+|\\d+\\.\\d+)\\b'
|
---|
| 404 | },
|
---|
| 405 | {
|
---|
| 406 | // integer in base up to 36
|
---|
| 407 | // Doesn't seem to recognize integers which end with '.'
|
---|
| 408 | begin: '\\b(\\d+|0[0-9A-Za-z]+)\\.?\\b'
|
---|
| 409 | }
|
---|
| 410 | ]
|
---|
| 411 | }
|
---|
| 412 | ],
|
---|
| 413 | illegal: /@/
|
---|
| 414 | };
|
---|
| 415 | }
|
---|
| 416 |
|
---|
| 417 | module.exports = maxima;
|
---|